Fact-checked by Grok 2 weeks ago

Sequence alignment

Sequence alignment is a computational method in bioinformatics that arranges two or more biological sequences, such as DNA, RNA, or amino acid chains, to identify regions of similarity indicative of shared evolutionary origins, structural features, or functional properties. This process involves inserting gaps to optimize the alignment based on scoring schemes that reward matches and penalize mismatches or insertions/deletions, enabling the inference of homology between sequences. The technique originated with pairwise alignments, which compare exactly two sequences, and can be categorized as global or local depending on whether the entire sequences or only specific subsequences are aligned. alignment, introduced by the Needleman-Wunsch algorithm in 1970, seeks the optimal end-to-end matching of sequences using dynamic programming to maximize similarity scores across their full lengths. In contrast, alignment, developed by the Smith-Waterman algorithm in 1981, focuses on the highest-scoring contiguous regions, which is particularly useful for detecting conserved domains within longer, dissimilar sequences. Multiple sequence alignment (MSA) extends pairwise methods to three or more sequences, revealing conserved motifs and patterns across a of related biomolecules, and is for advanced analyses like construction and secondary structure prediction. Common MSA tools, such as Omega, employ progressive alignment strategies that build alignments iteratively based on guide trees derived from pairwise similarities. Sequence alignment underpins numerous bioinformatics applications, including database searches via tools like for identifying homologous genes, functional annotation of newly sequenced genomes, and evolutionary studies to trace divergence among species. It also supports modeling by aligning sequences to known templates and aids in by highlighting conservation. Advances in high-throughput sequencing have increased the demand for efficient alignment algorithms, leading to heuristic approximations like and gapped to handle large-scale genomic data without exhaustive computation.

Fundamentals

Definition and Interpretation

Sequence alignment is the process of arranging sequences of DNA, RNA, or protein to identify regions of similarity, which may arise from shared evolutionary origins, structural constraints, or functional roles. This arrangement maximizes the correspondence between residues while allowing for gaps to represent insertions or deletions (indels) that occurred during evolution. The resulting alignment provides a framework for comparing sequences and quantifying their relatedness through a scoring function that rewards similarities and penalizes differences or gaps. In a biological context, sequence alignment serves to detect between sequences, infer evolutionary relationships by tracing descent from common ancestors, and highlight conserved regions indicative of functional or structural importance. For example, aligned sequences can reveal motifs critical for , enzyme activity, or regulatory elements in DNA, aiding in the prediction of and phylogenetic . Such interpretations rely on the assumption that similar sequences have undergone comparable evolutionary pressures, preserving key features over time. Fundamental terminology in sequence alignment includes (identical residues aligned vertically), mismatches (non-identical residues), and gaps ( symbols denoting indels, often penalized by length). Alignments are evaluated using scoring schemes, where matrices assign values to matches and mismatches based on observed evolutionary substitutions; notable examples are the (Percent Accepted Mutation) matrices, derived from closely related protein alignments by Dayhoff et al. in 1978, and the (BLOcks SUbstitution Matrix) series, constructed from conserved protein blocks by Henikoff and Henikoff in 1992. These matrices, such as PAM250 or BLOSUM62, provide higher scores for conservative substitutions (e.g., to ) than radical ones, reflecting biological likelihood. Gap penalties, typically affine (a plus per-position extension), further refine the score to balance alignment quality. The origins of sequence alignment trace back to the 1970s, when Margaret Dayhoff pioneered systematic computational approaches for aligning protein sequences as part of her Atlas of Protein Sequence and Structure, enabling the first large-scale comparisons of known proteins. This work laid the groundwork for modern bioinformatics by integrating sequence data with evolutionary models. For a simple illustrative example, consider the pairwise alignment of two short DNA sequences:
Seq1:  A T G C G T  
Seq2:  A T - C C T
Here, matches at positions 1–2 and 6 are conserved (e.g., the "AT" and "T" motifs), a gap in Seq2 accounts for an insertion in Seq1, and the mismatch at position 5 highlights a substitution; such alignments can reveal conserved regulatory motifs in non-coding DNA. Variants of this process, such as global or local alignments, extend the method to full or partial sequence comparisons, respectively.

Global versus Local Alignment

Global alignment seeks to align two entire sequences from end to end, maximizing similarity across their full lengths, and is particularly suitable for sequences of comparable length that exhibit overall , such as orthologous proteins or genes. This approach, exemplified by the Needleman-Wunsch algorithm, assumes that the sequences are homologous throughout and penalizes gaps to enforce complete coverage. It is ideal when the biological relationship involves conservation across the whole sequence, but it may produce suboptimal results if sequences have significant terminal or internal divergences. In contrast, local alignment focuses on identifying the highest-scoring regions of similarity between , without requiring alignment of the full sequences, making it appropriate for detecting conserved domains or motifs within otherwise divergent or unequally sized sequences. The Smith-Waterman algorithm represents this strategy, allowing for the detection of local homologies in larger genomic contexts where global methods might dilute significant but partial matches. Local alignments are computationally intensive for long sequences due to the need to explore all possible subsequence pairs, but they excel in scenarios involving functional elements embedded in non-homologous regions. The choice between and alignment depends on factors such as sequence length, degree of , and computational resources; methods are preferred for closely related sequences with similarity, while methods suit cases of high or interest in specific domains, though approaches incur higher costs for exhaustive searches. For instance, alignment is commonly applied to orthologous genes to assess evolutionary across their entirety, whereas alignment aids in discovery within expansive genomes to pinpoint regulatory or structural elements. Scoring systems in both incorporate gap penalties to balance matches and insertions/deletions, influencing the alignment's biological interpretability. Semi-global alignment serves as a strategy, aligning one full to a of another while permitting free gaps at the ends of the shorter , which is useful for applications like read mapping to reference genomes where terminal overhangs occur without penalization. This variant addresses limitations of pure global or local methods in scenarios involving partial overlaps, such as assembling contigs or aligning exons within genes.

Sequence Representations

Sequence alignments are commonly represented in text-based formats where the aligned biological sequences—such as DNA, RNA, or proteins—are arranged in rows, with homologous positions aligned in vertical columns and gaps inserted as hyphen characters ('-') to account for insertions or deletions. This columnar layout facilitates the identification of matches, mismatches, and conserved regions across sequences. For multiple sequence alignments, a consensus sequence is often derived below the aligned rows, representing the most frequent residue or base at each position, sometimes using ambiguity codes (e.g., 'N' for any nucleotide) to denote variability. A compact text-based notation for alignments, particularly in genomic contexts, is the CIGAR (Concise Idiosyncratic Gapped Alignment Report) string, which encodes the series of alignment operations between a query sequence and a reference using a sequence of integers followed by single-letter codes, such as 'M' for alignment match or mismatch, 'D' for deletion in the query, 'I' for insertion in the query, and others like 'S' for soft-clipped regions. Introduced in the Sequence Alignment/Map (SAM) format specification in 2009, CIGAR strings enable efficient storage and processing of alignments in bioinformatics pipelines, for example, "5M2D3M" indicates five matched bases, followed by two deletions, and then three more matches. This format is widely used in tools like SAMtools for handling large-scale sequencing data. Graphical representations provide visual aids for interpreting alignments, including dot plots that display sequence similarity as diagonal lines or clusters of points on a two-dimensional , where one sequence runs along each axis and dots mark matching k-mers or residues. Specialized viewers, such as Jalview, render alignments as color-coded rows of sequences, highlighting conserved regions (often in similar hues), gaps, and secondary structure annotations to enhance . These visualizations are applicable in both pairwise and multiple sequence alignments to reveal evolutionary relationships and functional motifs. Text-based representations, including , offer advantages in compactness for and ease of in computational workflows, making them suitable for high-throughput analysis. Graphical formats, while more intuitive for human analysis, support interactive exploration but require software rendering. However, linear text formats like aligned sequences or inherently discard three-dimensional structural context, potentially overlooking spatial relationships in protein alignments.

Pairwise Alignment Techniques

Dot-Matrix Methods

Dot-matrix methods, also known as dot plots, offer a graphical approach to visualize pairwise sequence similarities and identify repetitive elements in biological sequences such as DNA, RNA, or proteins. These methods plot sequences against each other or themselves to reveal patterns of conservation without requiring alignment optimization. To construct a dot plot, one sequence is aligned along the horizontal axis and the other along the vertical axis, creating a two-dimensional grid where each cell represents a pair of residues. A dot is placed in the cell (i, j) if the residue at position i in the first sequence matches or exceeds a predefined similarity threshold with the residue at position j in the second sequence. This threshold helps filter noise from random matches, focusing on biologically relevant similarities. In interpretation, continuous diagonal lines parallel to the indicate regions of strong sequence similarity or . Lines parallel to the highlight direct repeats, anti-diagonals signify inverted repeats, and off-diagonal segments can detect inversions or tandem duplications. The primary advantages of dot-matrix methods lie in their intuitive , enabling rapid of direct repeats, inverted repeats, and tandem duplications in sequences. They provide an immediate overview of structural features without the need for complex computations. However, these methods suffer from quadratic space and , making them inefficient for long sequences where the grid becomes densely populated with noise unless filtering is applied. Dot-matrix methods were introduced by Gibbs and McIntyre in as a simple diagrammatic tool for comparing and sequences. For example, a dot plot of a eukaryotic can reveal exons as short diagonal segments of high density, contrasting with the sparse regions corresponding to introns. While dot-matrix methods excel in visualization, they serve as a precursor to dynamic programming techniques that incorporate scoring for more precise alignments.

Dynamic Programming Algorithms

Dynamic programming algorithms provide an exact method for computing the optimal pairwise alignment of biological sequences by systematically evaluating all possible alignments through a scoring matrix. These approaches, pioneered in the late 1960s and early 1980s, guarantee the highest-scoring alignment under a given scoring scheme but incur quadratic time and space complexity, making them suitable for sequences up to moderate lengths. The Needleman-Wunsch algorithm, introduced in 1970, computes the optimal global alignment between two sequences by aligning them end-to-end, penalizing unaligned regions at the termini. It constructs a dynamic programming F where F(i,j) represents the optimal alignment score for the prefixes of sequences A[1..i] and B[1..j]. The is defined as: F(i,j) = \max \begin{cases} F(i-1,j-1) + s(A_i, B_j) \\ F(i-1,j) - d \\ F(i,j-1) - d \end{cases} Here, s(A_i, B_j) is the score for aligning residues A_i and B_j, and d is the linear for insertions or deletions. is initialized with F(0,0) = 0 and F(i,0) = -i \cdot d, F(0,j) = -j \cdot d, and the optimal alignment is recovered by traceback from F(n,m), where n and m are the sequence lengths. The Smith-Waterman algorithm, developed in , extends this framework to local alignments, identifying the highest-scoring pairs without forcing terminal alignments. It modifies the Needleman-Wunsch approach by initializing with zeros along the borders (F(0,j) = F(i,0) = 0) and adding a fourth option in the recurrence: \max(0, \dots), ensuring negative scores are set to zero to discard suboptimal partial alignments. Traceback begins from the maximum value in , terminating upon reaching a zero, which delineates the local alignment boundaries. This makes it particularly effective for detecting conserved domains within longer, divergent sequences. To better model biological insertions and deletions, which are often costlier to initiate than extend, affine gap penalties were introduced in 1982. Under this model, the cost of a gap of length k is -(h + (k-1)g), where h > 0 is the gap-opening penalty and g \geq 0 is the gap-extension penalty. Implementing affine penalties requires three auxiliary matrices to track states (match, insertion, deletion), increasing time complexity to O(nm) but with a constant factor of three compared to linear penalties; the recurrence for the primary matrix F incorporates maximums from these states. Substitution scores in these algorithms are derived from empirical matrices that reflect evolutionary relationships. The (Point Accepted Mutation) matrices, developed in 1978 from alignments of closely related proteins (at least 85% identity), model evolutionary distances in units of 1% accepted mutations and are extrapolated for global alignments of divergent sequences, with PAM250 commonly used for distant homologs. In contrast, (BLOcks SUbstitution Matrix) matrices, introduced in 1992 from conserved blocks in distantly related protein families, favor local alignments and are clustered by sequence identity (e.g., BLOSUM62 for 62% clustering threshold), outperforming PAM for detecting remote similarities. For DNA sequences, simpler identity-based scoring (+1 match, -1 mismatch) is often applied. Both algorithms exhibit O(nm) time and space complexity for sequences of lengths n and m, limiting practicality for large genomes. Space optimizations, such as Hirschberg's from , reduce memory to O(\min(n,m)) by recursively computing scores for halves of one sequence and using the midpoint to guide traceback, preserving optimality while halving space iteratively. Heuristics can approximate these for database-scale searches, but exact dynamic programming remains the gold standard for precision. As an illustrative example, consider aligning short DNA sequences "GAATTC" (sequence A) and "GATTA" (sequence B) using Needleman-Wunsch with +1, mismatch -1, and -2. The score matrix F is filled row-by-row:
  • Initialization: First row [0, -2, -4, -6, -8, -10]; first column [0, -2, -4, -6, -8, -10].
  • Key cells: F(1,1) = 1 (G-G ); F(2,2) = 2 (A-A ); proceeding to F(6,5) = 1.
The final matrix is:
εGATTA
ε0-2-4-6-8-10
G-21-1-3-5-7
A-4-120-2-4
A-6-301-1-1
T-8-5-2120
T-10-7-4-121
C-12-9-6-301
Traceback from F(6,5) = 1 yields paths: diagonal for matches/mismatches, horizontal/vertical for gaps. One optimal alignment is: GAATTC
G-ATTA
with score 1 (four matches, one mismatch, one gap).

Heuristic and Word-Based Methods

methods in sequence alignment prioritize computational efficiency over exhaustive optimality, making them suitable for large-scale database searches where exact dynamic programming would be prohibitively slow. These approaches typically employ a seed-and-extend strategy, identifying short exact matches (seeds or words) between query and database sequences to initiate alignment, followed by localized extension using simplified scoring. Word-based methods, in particular, index short subsequences—often k-mers of length 3 to 11— to rapidly locate potential homologous regions, reducing the search space from to near-linear . The Basic Local Alignment Search Tool (), introduced in , exemplifies this paradigm by scanning for exact word matches as seeds and extending them bidirectionally with a version of dynamic programming to form high-scoring segment pairs (HSPs). In BLAST, the query sequence is broken into overlapping words, which are indexed against a precomputed database ; matches exceeding a neighborhood word score threshold trigger extensions until the alignment score drops below a predefined drop-off value. This process approximates local alignments without gaps in the initial ungapped BLAST variant, enabling searches against vast repositories like in seconds rather than hours. Subsequent refinements addressed limitations in handling insertions and deletions. The ungapped BLAST requires continuous matches, potentially fragmenting alignments across indels, whereas gapped BLAST variants, developed in , incorporate two-hit heuristics: after an initial ungapped seed, a second nearby word match triggers a more sensitive gapped extension using banded dynamic programming, improving detection of divergent sequences while maintaining speed. Statistical significance of HSPs is assessed via the E-value, which estimates the number of alignments with equal or better scores expected by chance in a database of given size; lower E-values (e.g., < 10^{-5}) indicate reliable homology, adjusted for factors like sequence length and composition. Word-based methods extend beyond BLAST through techniques like maximal unique matches (MUMs), which identify the longest exact matches occurring uniquely in both sequences to anchor alignments in genome-scale comparisons. In tools like , MUMs are computed efficiently using suffix trees or enhanced suffix arrays, filtering out repetitive regions and enabling rapid sketching of conserved synteny without full alignment. This indexing of short exact matches (e.g., 3-mers) as seeds prioritizes unique anchors, scoring alignments based on MUM density and order to infer evolutionary relationships. BLAST's primary advantage lies in its speed for database searches, such as NCBI's implementation against , where it processes queries 50-100 times faster than full dynamic programming, facilitating routine annotation of millions of sequences. However, its heuristic nature trades optimality for efficiency, potentially missing distant homologs with low sequence identity (<25%) due to sparse seed hits, and it exhibits a sensitivity-specificity trade-off where relaxed parameters increase false positives. For example, in a protein database search using BLASTP, output parsing involves extracting HSPs from the tabular format (e.g., via -outfmt 6), where fields like max score, E-value, and percent identity rank hits; a query against UniProt might yield top matches with E-values near 0 and identities >40%, indicating strong homologs, while parsing scripts filter for query coverage >70% to prioritize full-length s.

Multiple Sequence Alignment Approaches

Progressive Alignment Methods

Progressive alignment methods for () involve constructing a hierarchical alignment by first computing pairwise similarities between sequences to build a guide tree, then progressively aligning sequences or clusters in the order dictated by the tree, starting with the most similar pairs. This heuristic approach transforms the computationally intensive MSA problem into a series of pairwise alignments, avoiding the of exact methods while aiming to preserve biological relevance. The guide tree, often generated using neighbor-joining or similar distance-based clustering from a matrix of pairwise scores, serves as a roadmap for sequential addition, ensuring that closely related sequences are aligned first to establish a robust core. The series represents one of the most influential implementations of progressive alignment, originating in the late 1980s and evolving through versions like and . In , pairwise alignments are first performed using dynamic programming to create a , from which a neighbor-joining guide tree is constructed; sequences are then added sequentially to the growing alignment, with initial alignments between the two most similar sequences followed by progressive incorporation of others. Later enhancements in introduced sequence weighting to emphasize informative positions and position-specific gap penalties, which increase penalties in conserved regions to discourage insertions or deletions there while allowing flexibility in variable areas, thereby better preserving functionally important motifs. further optimized this for scalability, enabling alignments of thousands of sequences through parallelization and mBed-like strategies for large clusters. These methods excel in efficiency, scaling well to dozens or hundreds of sequences with polynomial time complexity, making them practical for routine bioinformatics tasks. They are particularly valuable in , where aligned sequences form the basis for tree inference and evolutionary analysis, as the hierarchical structure mirrors expected evolutionary relationships. However, a key limitation is error propagation due to the "once a , always a " rule, where early alignment decisions—such as placements—are fixed and propagated through subsequent steps, potentially leading to inaccuracies in divergent sequences. A representative example is the of family proteins, such as human alpha- and beta-hemoglobins alongside , where progressive alignment highlights conserved alpha-helical regions essential for binding and oxygen transport, while accommodating variable loop insertions. Iterative refinements can sometimes mitigate these propagation issues by realigning subsets post-progression.

Iterative and Consistency-Based Methods

Iterative methods for multiple sequence alignment (MSA) begin with an initial alignment, often generated via progressive techniques, and then refine it through repeated realignments of subsets of sequences or resampling strategies to optimize an overall score. These approaches address limitations in progressive alignments by allowing corrections to early errors that propagate through the process. A key example is the Progressive, Recursive, and Permutation (PRRP) method, which uses iterative refinement with a double nested loop to ensure consistency among the alignment, guide tree, and sequence weights; it iteratively adjusts alignment weights and local alignments to maximize the sum-of-pairs (SP) score. PRRP starts with a progressive alignment and repeatedly refines the alignment by realigning against the current tree and weights until convergence, thereby improving accuracy on datasets with divergent sequences. Another prominent iterative strategy is the Partial Order Alignment () approach, which represents alignments as directed acyclic graphs rather than linear profiles to preserve branching structures and avoid forced consensus in variable regions. In POA, an initial progressive alignment is constructed by sequentially aligning new sequences to the evolving graph using dynamic programming, followed by iterative refinements that realign subsets against the graph to optimize the SP objective while accommodating indels and rearrangements. This graph-based iteration enables handling of up to hundreds of sequences efficiently. Consistency-based methods enhance by enforcing pairwise consistency across all sequence pairs in the , using a of high-quality pairwise alignments as anchors to guide the global . The seminal T-Coffee algorithm (2000) constructs such a consistency from external information, including structural alignments or precomputed pairs, and optimizes the by maximizing the sum of pairwise scores derived from this rather than a simple objective. For instance, T-Coffee can incorporate secondary structure anchors to align non-coding sequences, where it realigns pairs iteratively against the to resolve inconsistencies, yielding higher accuracy than progressive methods alone on datasets with low sequence identity. These iterative and consistency-based techniques generally outperform pure alignments in accuracy, particularly for datasets involving structural or functional constraints, while remaining computationally feasible for hundreds of sequences through optimizations. For example, T-Coffee's use of consistency libraries has demonstrated superior performance on alignments by integrating structural data compared to non-consistency methods.

Exact and Motif-Finding Methods

Exact dynamic programming (DP) methods for (MSA) extend the pairwise Needleman-Wunsch algorithm to multiple dimensions, computing the optimal alignment by filling a k-dimensional matrix for k sequences, each of length L. These approaches guarantee the globally optimal solution under a given scoring scheme but are computationally intensive, with a time and space complexity of O(L^k \cdot 2^k), where the $2^k factor arises from considering all possible combinations of matches or gaps at each position across the sequences. Due to this , exact DP is feasible only for small numbers of sequences, typically fewer than 10, and short sequence lengths, often limited to alignments of ribosomal RNA or small protein families. Tree-based exact DP variants, such as those aligning sequences according to a predefined , further optimize computation by decomposing the problem into pairwise alignments along tree branches, reducing redundancy while maintaining optimality for the tree topology. These methods are particularly useful for small sets of closely related sequences, like genomes, where the guides the alignment without approximations. However, even tree-based implementations remain impractical for larger k due to the underlying exponential scaling. Motif-finding methods complement exact DP by focusing on identifying short, conserved sequence blocks (motifs) rather than full alignments, which is valuable when sequences are unaligned or contain distant homologies. The MEME (Multiple Expectation maximization for Motif Elicitation) algorithm, introduced in 1994, uses an expectation-maximization (EM) framework to discover one or more motifs in a set of unaligned sequences by modeling them as mixtures of motifs and background distributions. In the E-step, MEME probabilistically assigns positions to motifs; in the M-step, it updates motif parameters to maximize the likelihood, iterating until . This approach excels at finding ungapped motifs of specified widths in DNA or protein sequences without requiring prior alignment. Gibbs sampling provides an alternative probabilistic strategy for motif discovery, iteratively sampling motif positions in all but one sequence while fixing the others, then updating the excluded sequence based on the current model to explore the posterior distribution of motif locations. This technique avoids local optima more robustly than by randomly perturbing assignments, making it suitable for discovering multiple motifs with variable spacing or in noisy datasets. Seminal implementations, such as the Gibbs Motif Sampler, have been applied to detect subtle patterns in large sequence collections. These methods find applications in identifying regulatory elements, such as transcription factor binding sites in promoter regions, and conserved protein domains that mediate functions like enzymatic activity or protein-protein interactions. For example, MEME and Gibbs sampling have been used to discover zinc-finger motifs—short cysteine- and histidine-rich sequences that bind DNA—in transcription factors across eukaryotic genomes, revealing conserved patterns like C2H2 that coordinate zinc ions for DNA recognition. Despite their precision, exact DP methods suffer from exponential complexity that limits scalability beyond small datasets, often requiring supercomputing resources even for modest k. Motif-finding approaches, while efficient, assume motifs as ungapped blocks and may overlook gapped or low-information patterns, necessitating integration with other tools for comprehensive analysis.

Structural Sequence Alignment

Protein Structure Comparison Metrics

Protein structure comparison metrics are essential for evaluating the similarity between three-dimensional protein conformations, particularly when integrating structural data with sequence alignments. These metrics quantify how well aligned residues in a sequence alignment correspond to spatially close positions in their folded structures, allowing for the assessment of evolutionary and functional relationships beyond sequence similarity alone. By measuring atomic or residue-level deviations after optimal superposition, they help validate whether sequence-based alignments reflect conserved structural features, which is crucial for applications like and functional annotation. The (RMSD) is a widely used metric that calculates the average distance between corresponding atoms in two superimposed protein structures. After aligning the structures via least-squares and translation to minimize deviations, RMSD is computed as the of the mean of the squared pairwise distances between N equivalent atoms: \text{RMSD} = \sqrt{\frac{1}{N} \sum_{i=1}^{N} d_i^2} where d_i is the between atom i in the two structures. This measure is sensitive to global conformation and is typically applied to backbone atoms like Cα for robustness, with lower values indicating greater similarity; values below 2 Å often signify high structural . The method originates from the optimal superposition that minimizes RMSD. The (TM-score) addresses limitations of RMSD by providing a topology-based, scale-independent measure normalized by protein , ranging from 0 (no similarity) to 1 (identical structures). Defined as \text{TM-score} = \frac{1}{L_{\text{target}}} \sum_{i=1}^{L_{\text{aligned}}} \frac{1}{1 + (d_i / d_0)^2}, where L_{\text{target}} is the of the target protein, L_{\text{aligned}} is the number of aligned residues, d_i is the between aligned residues i, and d_0 is a scaling factor (often 4.8 for globular proteins), TM-score emphasizes global and is robust to local perturbations or chain differences. A TM-score > 0.5 typically indicates the same fold, making it valuable for detecting remote homologs. This metric was developed to better assess quality in . The Global Distance Test (GDT), particularly the total score variant (GDT-TS), evaluates similarity by calculating the percentage of residues in a that lie within specified cutoffs (e.g., 1 , 2 , 4 , 8 ) from their equivalents in the reference after superposition. GDT-TS averages these percentages across the cutoffs, yielding a value between 0 and 100, where higher scores reflect better agreement; it is less sensitive to outliers than RMSD and focuses on residue-level correspondence. Introduced for evaluating predictions in assessments starting from CASP3, with the total score variant used in subsequent assessments, GDT is effective for comparing models with varying alignment lengths. In structural sequence alignment, these metrics score the quality of overlays derived from sequence alignments, enabling refinement or validation of alignments by prioritizing those with low RMSD, high TM-score, or high GDT. For instance, a sequence alignment can guide initial residue pairing, after which structures are superposed and metrics computed to assess fit. Structural metrics offer advantages over sequence-based scores by capturing functional similarities in proteins with low sequence identity (<30%), where obscures primary sequence conservation but preserves core folds essential for or . A representative example is the comparison of and the alpha chain of , homologous oxygen-binding proteins sharing approximately 25% sequence identity. Despite this modest sequence similarity, reveals conserved folds, with low RMSD values for superposed Cα atoms confirming high conformational overlap and functional analogy in coordination.

Key Algorithms for Structural Alignment

Structural alignment algorithms aim to superimpose three-dimensional protein structures to identify similarities in their , even when sequences diverge significantly. These methods typically operate on atomic coordinates, prioritizing spatial proximity and geometric consistency over linear sequence order. Prominent approaches include distance-based and fragment-based techniques that iteratively refine alignments to maximize structural overlap while accounting for flexibility. The (Distance matrix ALIgnment) , introduced by Holm and Sander in 1993, performs pairwise structural comparisons by aligning intra-molecular derived from Cα atom coordinates. It identifies similar segments through an iterative process that superimposes structurally equivalent regions, optimizing for a score that balances residue similarity and gap penalties, thereby detecting distant homologs effectively. has been widely used for database scanning and fold classification due to its robustness against local distortions. SSAP (Sequential Structure Alignment Program), developed by Orengo and in , employs a combinatorial extension of double dynamic programming to match secondary structure elements while considering three-dimensional geometry. The method first aligns vectors between residue pairs in conserved regions, then extends alignments using a scoring function that incorporates environmental and physicochemical properties, ensuring sequential order is preserved for biologically relevant comparisons. SSAP excels in handling proteins with insertions or deletions, facilitating the classification of domain architectures in large structural databases. The Combinatorial Extension (CE) algorithm, proposed by Shindyalov and Bourne in , builds alignments by identifying short aligned fragment pairs (AFPs) based on spatial superposition and extending them combinatorially to form a global path. It uses rigid-body superposition to minimize deviations, followed by optimization of the length and RMSD () to evaluate quality. CE is particularly effective for aligning structures with non-sequential similarities, such as circular permutations, and supports multiple structure alignments through iterative pairwise comparisons. A notable recent advance is TM-align, developed by Zhang and Skolnick in 2005, which optimizes alignments using the TM-score—a scale-independent metric that emphasizes global over local distortions. The algorithm applies a dynamic programming approach to superimpose structures, iteratively refining rotations and translations to maximize the TM-score, often outperforming earlier methods in accuracy for low-identity pairs. TM-align integrates sequence information optionally to enhance detection of remote homologs. These algorithms generally take as input Protein Data Bank (PDB) files containing three-dimensional coordinates of protein atoms, typically focusing on backbone Cα positions for computational efficiency. Outputs include superimposed coordinate sets, aligned residue mappings that can be converted to sequence alignments, and quantitative scores such as alignment length, RMSD, and similarity indices for assessing structural conservation. For validation, metrics like RMSD measure atomic deviations post-superposition, with values below 3 Å indicating significant similarity. An illustrative application involves aligning active sites across protein families, such as comparing the catalytic cores of serine proteases from different superfamilies using or , revealing conserved geometries despite sequence divergence and aiding in functional .

Applications in Biology

Role in Phylogenetic Analysis

Sequence alignment plays a foundational role in phylogenetic analysis by providing the structural framework necessary for inferring evolutionary relationships among organisms. Multiple sequence alignments (MSAs) serve as a prerequisite step, enabling the identification of homologous residues across sequences before applying substitution models that account for evolutionary changes such as and insertions/deletions. By aligning sequences to reveal positional correspondences, MSAs facilitate the construction of phylogenetic trees that represent hypothesized ancestry, with assessments directly informing the reliability of downstream inferences. To ensure the robustness of alignments used in , statistical measures such as E-values and p-values are employed to evaluate the significance of similarities, particularly in initial pairwise or database searches akin to . These metrics derive from Karlin-Altschul statistics, which model the expected distribution of scores under a of random similarity, allowing researchers to distinguish biologically meaningful homologies from chance matches. Once an is established, tree credibility is further assessed through bootstrap resampling, where columns of the alignment are randomly sampled with replacement to generate replicate datasets; the proportion of replicates supporting a given provides a measure of branch reliability, as introduced by Felsenstein. Phylogenetic tree-building relies on scoring functions applied to the aligned sequences to optimize tree topologies, contrasting methods—which seek the tree requiring the fewest evolutionary changes—with likelihood-based approaches that maximize the probability of observing the data under a specified evolutionary model. For instance, likelihood scoring under the Jukes-Cantor model assumes equal frequencies and substitution rates, providing a probabilistic to evaluate trees by incorporating branch lengths and transition probabilities. These aligned sequences are then integrated into specialized tools like MrBayes for or RAxML for , where the serves as direct input to compute posterior probabilities or optimized likelihoods for tree topologies. A prominent example of sequence alignment's application in is the use of (rRNA) MSAs to reconstruct bacterial evolutionary histories, as pioneered in Woese's foundational work, which aligned conserved and variable regions to delineate major and reveal universal tree structures. Structural alignments of protein domains can also briefly support such rRNA-based trees by incorporating three-dimensional for deeper divergences.

Other Biological Applications

Sequence alignment plays a crucial role in by facilitating the identification of through comparisons with known , particularly in genome assembly projects. Tools like integrate spliced alignments to annotate coding and conserved non-coding regions in homologous sequences, enabling finding across . Similarly, the spliced alignment algorithm in GeneWise aligns genomic DNA to protein sequences, exploring possible exon assemblies in time to delineate multiexon structures. These methods leverage sequence similarity to detect conserved splicing signals and start/stop codons, improving accuracy in eukaryotic genomes where introns complicate . In functional annotation, sequence alignments enable the transfer of (GO) terms based on , accelerating the assignment of biological roles to uncharacterized proteins. The BLAST2GO suite performs BLAST-based alignments against databases like NCBI nr, followed by GO mapping and annotation, allowing researchers to infer functions from sequence similarity in high-throughput genomics. This approach has been widely adopted for plant and microbial proteomes, where it integrates InterProScan for domain detection to refine annotations and support in . Variant analysis in next-generation sequencing (NGS) pipelines relies on aligning short reads to a to detect single nucleotide polymorphisms () and other variants. The Burrows-Wheeler Aligner (BWA) efficiently maps reads using backward search with the Burrows-Wheeler transform, providing high accuracy for large-scale resequencing. Subsequent SNP calling with the Genome Analysis Toolkit (GATK) processes these alignments through realignment and recalibration to minimize errors, enabling reliable genotype determination in clinical and population studies. In , sequence alignments underpin to predict structures of target proteins lacking experimental data, facilitating . The MODELLER program constructs 3D models by satisfying spatial restraints derived from alignments with template structures, optimizing side-chain packing and loop conformations for targets with 30-50% sequence identity. This has been instrumental in designing inhibitors for proteins like kinases, where aligned homologs guide the identification of binding sites conserved across families. For RNA structure prediction, alignments of related sequences inform covariance models that capture both primary sequence and secondary structure covariations. Introduced by Eddy and Durbin, these probabilistic models generalize hidden Markov models to include base-pairing probabilities, enabling sensitive homology searches. The Infernal software implements covariance models for aligning and searching RNA families, such as in the Rfam database, to predict structures in non-coding RNAs like tRNAs and ribozymes. An illustrative application is in , where aligning short reads from environmental samples to microbial reference reveals . MetaPhlAn profiles taxa by reads to clade-specific marker genes via Bowtie alignments, estimating relative abundances without full assembly and uncovering uncultured species in complex ecosystems like the human gut.

Advanced and Non-Biological Uses

Machine Learning Enhancements

has revolutionized sequence alignment by addressing limitations in traditional scoring matrices and methods, particularly for distant homologs and complex multiple sequence alignments (MSAs). Neural networks, such as protein models (pLMs), replace position-specific scoring matrices (PSSMs) with learned embeddings that capture evolutionary and structural contexts more effectively. For instance, pLM-BLAST employs ESM-2 embeddings to detect distant homologies by comparing representations, outperforming in low-identity cases with up to 20% higher on datasets. Similarly, Protein Embedding based Alignments (PEbA) uses transformer-derived embeddings to align sequences with less than 20% identity, improving accuracy over traditional tools like Clustal Omega by incorporating semantic similarities beyond pairwise substitutions. Inspired by AlphaFold's success in structure prediction, recent approaches integrate predicted structural embeddings into alignment scoring for enhanced detection of remote homologs. The Ankh-score method (preprint) leverages AlphaFold3-generated structures to refine sequence alignments, achieving superior performance in identifying homologs with low sequence identities compared to TM-align, as demonstrated on BAliBASE and CDD datasets. These embeddings encode three-dimensional constraints directly into the scoring function, enabling alignments that align not just residues but also functional motifs across divergent proteins. DeepBLAST further extends this by combining structural vectors (TM-Vec) with sequence embeddings, boosting remote homology detection accuracy by 10-15% over on diverse protein families. For alignment refinement, convolutional neural networks (CNNs) and correct errors in initial MSAs, particularly in sparse or noisy datasets. DeepMSA, introduced in 2019, constructs deep MSAs by iteratively refining alignments using multi-source homologous sequences, improving contact prediction accuracy by 5-10% for distant-homology proteins when integrated with tools like trRosetta. Its successor, DeepMSA2, employs architectures to generate high-quality MSAs for both monomers and multimers, reducing alignment errors in low-homology scenarios. BetaAlign, a 2024 deep learning framework, trains on simulated alignments to perform end-to-end MSA optimization, surpassing progressive methods like MAFFT in handling insertions and deletions with a 12% gain in column score on simulated benchmarks. Post-2020 advances incorporate diffusion models for structure-aware alignments, simulating evolutionary processes to handle ultra-low-identity cases better than . ESM3, released in 2024, uses a diffusion-based to evolve protein sequences over simulated timelines, enabling alignments that recover homologs with <10% identity by modeling co-evolutionary dynamics, as validated on 500 million years of synthetic evolution data. These models facilitate end-to-end learning, where alignments are optimized jointly with downstream tasks like structure prediction, yielding significant improvements in for metagenomic datasets where traditional methods fail due to fragmented assemblies. In , such enhancements increase functional annotation accuracy over -based pipelines, as shown in large-scale microbial community analyses. Overall, these integrations provide greater for divergent sequences and scalable processing of massive datasets, marking a shift toward predictive, context-aware paradigms.

Applications Outside Biology

Sequence alignment techniques, originally developed for , have found significant applications in non-biological domains, particularly in and . One of the earliest adaptations emerged in the with the introduction of metrics for string comparison in . The , proposed in 1965, measures the minimum number of single-character edits—insertions, deletions, or substitutions—required to transform one string into another, providing a foundational method for aligning non-biological sequences. This metric was further refined by the Wagner-Fischer algorithm in 1974, which efficiently computes edit distances using dynamic programming, enabling practical implementations for string alignment in early tasks. In natural language processing, string alignment via Levenshtein distance is widely employed for spell-checking, where it identifies and suggests corrections for typographical errors by quantifying deviations from dictionary words. For instance, autocorrect systems in word processors and search engines use this distance to rank potential fixes based on minimal edit operations. Similarly, plagiarism detection tools apply edit distance to compare documents or code snippets, flagging similarities that exceed a threshold after normalizing for minor variations like rephrasing or formatting changes; this approach has been validated in systems analyzing both textual and source code content for academic and software integrity checks. In software engineering, these methods extend to tracking code evolution, treating source code versions as sequences to align and detect "code clones" or evolutionary changes, akin to genomic comparisons but focused on refactoring and duplication analysis. Beyond text, sequence alignment principles underpin analysis through algorithms like (DTW), which aligns signals of varying speeds or lengths by minimizing the distance between corresponding points. Developed in 1978 for , DTW warps temporal axes to match patterns, such as aligning spoken words despite differences in pronunciation speed or pauses. This technique is routinely used in for applications like in human-computer interfaces and in sensor data, where non-linear alignments reveal underlying similarities not captured by rigid metrics. Bioinformatics-inspired alignments also appear in forensics, where sequences—short genetic markers—are aligned against reference databases to identify species in illicit trade or crime scenes, such as verifying products at without full genomic sequencing. In , protein sequence alignment concepts inspire the design of synthetic polymers; for example, aligning motifs from proteins guides the generation of novel sequences to engineer biomaterials with enhanced tensile strength and . Despite these successes, adapting biological sequence alignment to non-biological contexts faces limitations, as scoring schemes like substitution matrices (e.g., ) rely on evolutionary models irrelevant to strings or signals, necessitating simpler uniform costs that may overlook domain-specific nuances like semantic meaning in text.

References

  1. [1]
    Sequence Alignment - Handbook of Discrete and Combinatorial ...
    Sequence alignment compares related DNA or protein sequences, capturing common evolutionary descent or structural function. It represents a hypothesis of ...PAIRWISE ALIGNMENT... · PATH GRAPHS AND... · SEQUENCE ALIGNMENT...
  2. [2]
    A General Method Applicable to the Search for Similarities in the ...
    A computer adaptable method for finding similarities in the amino acid sequences of two proteins has been developed. From these findings it is possible to ...
  3. [3]
    [PDF] Identification of Common Molecular Subsequences
    The identification of maximally homologous subsequences among sets of long sequences is an important problem in molecular sequence analysis. The problem is.
  4. [4]
    The Historical Evolution and Significance of Multiple Sequence ...
    Multiple sequence alignment (MSA) is the process of aligning three or more biological sequences, typically protein, DNA, or RNA, to identify regions of ...
  5. [5]
    Clustal Omega < Job Dispatcher < EMBL-EBI
    Clustal Omega is a new multiple sequence alignment program that uses seeded guide trees and HMM profile-profile techniques to generate alignments between three ...
  6. [6]
    BLAST: Basic Local Alignment Search Tool
    Call BLAST from your application · Use BLAST in the cloud. Start an ... Multiple Alignment. Align sequences using domain and protein constraints. Follow NCBI.Align Sequences
  7. [7]
    [PDF] Basic Local Alignment Search Tool
    Global similarity algorithms optimize the overall alignment of two sequences, which may include large stretches of low similarity (Needleman. & Wunsch, 1970).Missing: original | Show results with:original
  8. [8]
    Amino acid substitution matrices from protein blocks. - PNAS
    We have derived substitution matrices from about 2000 blocks of aligned sequence segments characterizing more than 500 groups of related proteins.
  9. [9]
    the making of Margaret O. Dayhoff's Atlas of Protein Sequence and ...
    This paper explores the historical development of these practices, focusing on the work of Margaret O. Dayhoff, Richard V. Eck, and Robert S. Ledley.
  10. [10]
    Celebrating Women's History: Margaret Oakley Dayhoff - Plant Biology
    Mar 31, 2023 · Dayhoff also authored the “Atlas of Protein Sequence and Structure,” a book collecting and cataloging all 65 protein sequences known at the time ...
  11. [11]
    Chapter 3: Sequence Alignments – Applied Bioinformatics
    Sequence alignment is the process of arranging the characters of a pair of sequences such that the number of matched characters is maximized.
  12. [12]
    A general method applicable to the search for similarities in the ...
    A computer adaptable method for finding similarities in the amino acid sequences of two proteins has been developed.Missing: original | Show results with:original
  13. [13]
    Comparative analysis of the quality of a global algorithm and a local ...
    Oct 27, 2011 · We revealed criteria allowing to specify conditions of preferred applicability for the local and the global alignment algorithms depending on ...
  14. [14]
    Identification of common molecular subsequences - ScienceDirect
    Journal of Molecular Biology, Volume 147, Issue 1, 25 March 1981, Pages 195-197, Letter to the editor, Identification of common molecular subsequences.
  15. [15]
    Needleman-Wunsch alignment of two nucleotide sequences - BLAST
    A global alignment aligns two sequences from beginning to end, aligning each letter in each sequence only once.An alignment is produced, regardless of whether ...
  16. [16]
    Parasail: SIMD C library for global, semi-global, and local pairwise ...
    Feb 10, 2016 · This article presents the first software library for local, global, and semi-global pairwise intra-sequence alignments and improves the ...Implementation · Threading Evaluation · Scoring System Evaluation<|separator|>
  17. [17]
    Sequence alignments — Biopython 1.85 documentation
    Files in the aligned FASTA format store exactly one (pairwise or multiple) sequence alignment, in which gaps in the alignment are represented by dashes ( - ).
  18. [18]
    Understanding Sequence Alignment - Geneious
    Sequence alignment is the process of comparing two or more DNA, RNA, or protein sequences to identify similarities between them.
  19. [19]
    Retroviral Sequences - Retroviruses - NCBI Bookshelf - NIH
    The easiest and most elegant way of doing this is through dot matrix analysis, or dot plot analysis. ... sequence alignment is necessary. For a distance ...
  20. [20]
    The diagram, a method for comparing sequences. Its use ... - PubMed
    Its use with amino acid and nucleotide sequences. Eur J Biochem. 1970 Sep;16(1):1-11. doi: 10.1111/j.1432-1033.1970.tb01046.x. Authors. A J Gibbs, G A McIntyre.Missing: dot original paper
  21. [21]
    Examples and interpretations of dot plots
    Contrary to simple sequence alignments dot plots can be a very useful tool for spotting various evolutionary events which may have happened to the sequences of ...Missing: construction advantages limitations
  22. [22]
    BLAST QuickStart - Comparative Genomics - NCBI Bookshelf - NIH
    ... dot plot representation of these alignments. The dot plot is useful for highlighting deletions and duplications of segments between two sequences. The ...
  23. [23]
    SeqTools: visual tools for manual analysis of sequence alignments
    Jan 22, 2016 · The SeqTools package provides three interactive tools for viewing different types of sequence alignment: Blixem, Dotter and Belvu.Missing: interpretation limitations
  24. [24]
    Annotation of a Drosophila Gene
    Dec 28, 2022 · The alternating color boxes correspond to the different coding exons in the two sequences. Dots in the dot plot correspond to regions of ...
  25. [25]
    [PDF] dayhoff-1978-apss.pdf
    The 1 PAM matrix can be multiplied by itself N times to yield a matrix that predicts the amino acid replace- ments to be found after N PAMs of evolutionary ...Missing: paper | Show results with:paper
  26. [26]
    A linear space algorithm for computing maximal common ...
    This paper presents an algorithm that solves the problem of finding a longest common subsequence in quadratic time and linear space.Missing: paper | Show results with:paper
  27. [27]
    Pairwise global alignment of DNA sequences using the Needleman ...
    Nov 11, 2021 · For example, if we want to compute the score for a global alignment of two short DNA sequences 'GAATTC' and 'GATTA', we can use the Needleman- ...
  28. [28]
    Progressive sequence alignment as a prerequisitetto correct ...
    A progressive alignment method is described that utilizes the Needleman and Wunsch pairwise alignment algorithm iteratively to achieve the multiple alignme.
  29. [29]
    CLUSTAL: a package for performing multiple sequence alignment ...
    An approach for performing multiple alignments of large numbers of amino acid or nucleotide sequences is described.Missing: original paper
  30. [30]
    improving the sensitivity of progressive multiple sequence alignment ...
    The sensitivity of the commonly used progressive multiple sequence alignment method has been greatly improved for the alignment of divergent protein sequences.Missing: original | Show results with:original
  31. [31]
    Multiple Sequence Alignment in Phylogenetic Analysis - ScienceDirect
    Multiple sequence alignment is discussed in light of homology assessments in phylogenetic research. Pairwise and multiple alignment methods are reviewed.
  32. [32]
    Evaluation of iterative alignment algorithms for multiple alignment
    An alternative method of using iteration for multiple sequence alignment is to incorporate it into a progressive alignment strategy. This is shown in Figure 1.
  33. [33]
    Multiple sequence alignment using partial order graphs
    This enables our algorithm (Partial Order Alignment (POA)) to guarantee that the optimal alignment of each new sequence versus each sequence in the MSA will be ...
  34. [34]
    The accuracy of several multiple sequence alignment programs for ...
    Oct 24, 2006 · POA is another MSA package that uses a progressive alignment algorithm without using generalized profiles. This program introduces the use of a ...
  35. [35]
    Recent Evolutions of Multiple Sequence Alignment Algorithms
    Aug 31, 2007 · The purpose of an MSA algorithm is to assemble alignments reflecting the biological relationship between several sequences. Computing exact MSAs ...<|control11|><|separator|>
  36. [36]
    An Improved Search Algorithm for Optimal Multiple-Sequence ...
    Aug 9, 2025 · Needleman's method [15] also seems exhaustive to build optimal multiple sequence alignment, as the time consumption is O(2 k L k ) . ...
  37. [37]
    An algorithm for progressive multiple alignment of sequences with ...
    We describe a modification of the traditional alignment algorithm that can distinguish insertion from deletion and avoid repeated penalization of insertions.Missing: PRRP permutation
  38. [38]
    An Improved Algorithm for Statistical Alignment of Sequences ...
    ... time complexity, to binary trees (Hein, 2001). ... 2(k)L(k)) and considerably reducing memory requirements. ... multiple sequence alignment and phylogenetic tree ...
  39. [39]
    Fitting a mixture model by expectation maximization to discover ...
    The algorithm described in this paper discovers one or more motifs in a collection of DNA or protein sequences by using the technique of expectation ...
  40. [40]
    [PDF] Learning Sequence Motifs Using Expectation Maximization (EM ...
    The MEME Algorithm. • Bailey & Elkan, 1993. • uses EM algorithm to find multiple motifs in a set of sequences. • first EM approach to motif discovery: Lawrence ...
  41. [41]
    Using ChIPMotifs for De Novo Motif Discovery of OCT4 and ZNF263 ...
    The overall workflow can be summarized as follows: (1) select input sequences; (2) run Weeder, MEME, and MaMF on the input; (3) use bootstrap re-sampling and ...
  42. [42]
    Motif discovery using expectation maximization and Gibbs' sampling
    Expectation maximization and Gibbs' sampling are two statistical approaches used to identify transcription factor binding sites and the motif that represents ...Missing: bioinformatics | Show results with:bioinformatics
  43. [43]
    Scoring function for automated assessment of protein structure ...
    Oct 8, 2004 · We have developed a new scoring function, the template modeling score (TM-score), to assess the quality of protein structure templates and predicted full- ...
  44. [44]
    [PDF] Processing and Analysis of CASP3 Protein Structure Predictions
    Comparing LCS and GDT plots allows to immediately identify if the observed structural similarity is localized or if it extends to multiple regions in protein's.Missing: URL | Show results with:URL
  45. [45]
    Protein sequence comparison based on the wavelet transform ...
    Myoglobin and hemoglobin are composed of an association of smaller subunits (α- and β-chains) and are thought to be evolutionarily related (Lehninger et al., ...
  46. [46]
    [PDF] Strengths and Limits of Multiple Sequence Alignment and Filtering ...
    Nov 26, 2020 · The most widespread one involves progressive alignment construction guided by hierarchical sequence clustering (Feng and Doolittle, 1987).
  47. [47]
    Next-generation phylogenomics | Biology Direct | Full Text
    Jan 22, 2013 · The aim of MSA is to arrange sequence regions relative to each other in a way that presents (to the tree-inference software) the best available ...
  48. [48]
    Multiple Sequence Alignment in Phylogenetic Analysis
    Aug 7, 2025 · Multiple sequence alignment is discussed in light of homology assessments in phylogenetic research. Pairwise and multiple alignment methods are reviewed as ...
  49. [49]
    Statistical significance in biological sequence analysis
    In this review we discuss the general role of P-value estimation in sequence analysis, and give a description of theoretical methods and computational ...
  50. [50]
    Renewing Felsenstein's Phylogenetic Bootstrap in the Era of Big Data
    We propose a new version of phylogenetic bootstrap, in which the presence of inferred branches in replications is measured using a gradual “transfer” distance.
  51. [51]
    Phylogenetic analysis using parsimony and likelihood methods
    Parsimony assumes constant substitution rates and equal branch lengths. Likelihood method is preferable when substitution rates differ, but both can recover ...Missing: scoring | Show results with:scoring
  52. [52]
    Contest Between Parsimony and Likelihood | Systematic Biology
    Besides saying what the “best” tree is for a given data set, both methods also provide an ordering of trees, from best to worst. The two methods sometimes ...
  53. [53]
    RAxML-III: a fast program for maximum likelihood-based inference of ...
    ... MrBayes outperforms all other analyzed phylogeny programs in terms of speed and tree quality. MrBayes is a program for bayesian analysis of phylogenetic trees.
  54. [54]
    A Comprehensive Protocol for Bayesian Phylogenetic Analysis ...
    Apr 20, 2025 · A Comprehensive Protocol for Bayesian Phylogenetic Analysis Using MrBayes: From Sequence Alignment to Model Selection and Phylogenetic Inference.
  55. [55]
    Phylogenies of the 16S rRNA gene and its hypervariable regions ...
    Jul 8, 2022 · The 16S rRNA gene is used extensively in bacterial phylogenetics, in species delineation, and now widely in microbiome studies.
  56. [56]
    General Substitution Matrix for Structural Phylogenetics
    Our 3Di substitution matrix provides a starting point for revisiting many deep phylogenetic problems that have so far been extremely difficult to solve.Missing: prerequisite | Show results with:prerequisite
  57. [57]
    pLM-BLAST: distant homology detection based on direct ...
    Currently, the primary limitations of pLM-BLAST are the maximum size of the target database (as searching enormous, redundant databases containing millions of ...Missing: specificity | Show results with:specificity
  58. [58]
    Protein embedding based alignment | BMC Bioinformatics | Full Text
    Feb 28, 2024 · We developed Protein Embedding based Alignments, or PEbA, to better align sequences with low pairwise identity.
  59. [59]
    Protein remote homology detection and structural alignment ... - Nature
    Sep 7, 2023 · Exploiting sequence–structure–function relationships in biotechnology requires improved methods for aligning proteins that have low sequence ...
  60. [60]
    DeepMSA: constructing deep multiple sequence alignment to ...
    We developed DeepMSA, a new open-source method for sensitive MSA construction, which has homologous sequences and alignments created from multi-sources of whole ...
  61. [61]
    BetaAlign: a deep learning approach for multiple sequence alignment
    We show that our artificial intelligence (AI)-based methodology can be trained to align sequences by processing alignments that are generated via simulations.2 Materials And Methods · 2.9 Subspace Learning... · 3.2 Effect Of Indel Model...
  62. [62]
    ESM3: Simulating 500 million years of evolution with a language ...
    Jun 25, 2024 · ESM3 solves harder generative problems as a function of scale, and the capabilities of larger models become more apparent after alignment.
  63. [63]
    Deep learning methods in metagenomics: a review - PMC
    This article reviews DL approaches in metagenomics, including convolutional networks, autoencoders and attention-based models.
  64. [64]
    [PDF] Binary codes capable of correcting deletions, insertions, and reversals
    Original article submitted January 2, 1965. Investigations of transmission of binary infor- mation usually consider a channel model in which failures of the ...
  65. [65]
    [PDF] SPELL CORRECTION AND SUGGESTION USING LEVENSHTEIN ...
    Oct 4, 2021 · Many fields like spell checking, speech recognition, DNA analysis, and plagiarism detection use the Levenshtein. Distance (LD) algorithm. The ...
  66. [66]
    EDA IA2 -Plagiarism Checker Application of Levenshtein Distance
    The application gives two options to the user, first to check plagiarism in two Strings and second to check plagiarism between two files.
  67. [67]
  68. [68]
    Dynamic Time Warping (DTW) in Time Series - GeeksforGeeks
    May 1, 2025 · Dynamic Time Warping (DTW) is an algorithm used to compare two time-based datasets (like two sequences of numbers) to find similarities.
  69. [69]
    Generative Modeling, Design, and Analysis of Spider Silk Protein ...
    Dec 2, 2023 · The authors develop a generative modeling, design, and analysis technique applied to create novel spider silk protein sequences for enhanced ...1 Introduction · 2 Results And Discussion · 4 Experimental Section
  70. [70]
    A review on multiple sequence alignment from the perspective of ...
    Sequence alignment (SA) is usually the first step performed in bioinformatics to understand the molecular phylogeny of an unknown sequence. This is done by ...Review · 8. Stochastic Approaches · 8.1. Genetic Algorithm