Skip to main content

Tools for integrated sequence-structure analysis with UCSF Chimera

Abstract

Background

Comparing related structures and viewing the structures in the context of sequence alignments are important tasks in protein structure-function research. While many programs exist for individual aspects of such work, there is a need for interactive visualization tools that: (a) provide a deep integration of sequence and structure, far beyond mapping where a sequence region falls in the structure and vice versa; (b) facilitate changing data of one type based on the other (for example, using only sequence-conserved residues to match structures, or adjusting a sequence alignment based on spatial fit); (c) can be used with a researcher's own data, including arbitrary sequence alignments and annotations, closely or distantly related sets of proteins, etc.; and (d) interoperate with each other and with a full complement of molecular graphics features. We describe enhancements to UCSF Chimera to achieve these goals.

Results

The molecular graphics program UCSF Chimera includes a suite of tools for interactive analyses of sequences and structures. Structures automatically associate with sequences in imported alignments, allowing many kinds of crosstalk. A novel method is provided to superimpose structures in the absence of a pre-existing sequence alignment. The method uses both sequence and secondary structure, and can match even structures with very low sequence identity. Another tool constructs structure-based sequence alignments from superpositions of two or more proteins. Chimera is designed to be extensible, and mechanisms for incorporating user-specific data without Chimera code development are also provided.

Conclusion

The tools described here apply to many problems involving comparison and analysis of protein structures and their sequences. Chimera includes complete documentation and is intended for use by a wide range of scientists, not just those in the computational disciplines. UCSF Chimera is free for non-commercial use and is available for Microsoft Windows, Apple Mac OS X, Linux, and other platforms from http://www.cgl.ucsf.edu/chimera.

Background

Integration of protein sequence and structure information is essential in many problem domains, including structural biology, protein engineering, and drug design. A suite of tools within UCSF Chimera [1] has been developed for studying sequence-structure relationships and comparing related structures.

Common tasks in sequence-structure work include: (A) displaying information from a sequence alignment on one or more corresponding structures, or displaying information from the structures on the alignment; (B) superimposing structures so that they can be compared; (C) generating a structure-based sequence alignment.

The Multalign Viewer extension of Chimera displays sequence alignments and automatically associates structures with sequences in the alignment. Structures can be superimposed using the alignment, and sequence-related data such as conservation can be shown on the structures. If one does not already have a sequence alignment, the MatchMaker extension can be used to generate sequence alignments and superimpose structures accordingly. A novel score incorporating both secondary structure and residue type is used to align the sequences. Completing the cycle, the Match -> Align extension constructs sequence alignments from pre-existing superpositions of structures.

These tools work together within Chimera to enhance the understanding of sequence information in the context of structure and vice versa. Below, we describe the tools in more detail and discuss their advantages and disadvantages relative to other programs.

Implementation

The implementation of the Chimera system is described elsewhere [1]. The tools described in this paper (Multalign Viewer, MatchMaker, Match -> Align) are all implemented as extensions to Chimera and are distributed along with Chimera. They are written in the Python scripting language and their user interfaces are implemented using Tkinter, Python's interface to the Tk GUI toolkit. Chimera's normal extension mechanisms are used to make the tools available in Chimera's "Tools" menu and to register file types that the tools can open, which then appear in the list of types in Chimera's main file-opening dialog.

The Multalign Viewer, MatchMaker, and Match -> Align tools are accessed from the Structure Comparison section of the Tools menu. Descriptions of parameters refer to the default settings in Chimera version 1.2199.

Results and discussion

Multalign Viewer

Sequence alignments in several common formats (Clustal ALN, aligned FASTA, GCG MSF, GCG RSF, aligned NBRF/PIR, and Stockholm) can be opened in Chimera and shown with Multalign Viewer. When a sequence alignment and a structure have been opened in Chimera (in either order), the sequence of the structure is compared to each of the sequences in the alignment. The structure is then associated with the alignment sequence that yields the fewest mismatches, if within a user-specified tolerance. The default mismatch tolerance is 1/10 the number of residues in the structure chain. Reasons for mismatches include point mutations, portions of a structure missing due to insufficient density for coordinates to be determined, and association with a homologous protein rather than the same protein (a useful sequence alignment might not include the sequence of the structure of interest, or even any sequence for which a structure is known). For rapid automatic association, it is assumed that gaps in the structure sequence relative to the alignment sequence can only occur where residues are missing from the structure. Multiple structures can be associated with multiple sequences, or even with the same sequence. When a sequence is associated with a structure, its name is shown in bold over a rectangle of the structure's default color (or if the sequence is associated with multiple structures, a dashed outline).

Sequence-structure associations can be changed or added if the automatic procedure does not give the desired result. If an association did not meet the criteria for the automated approach but is requested by the user, the Needleman-Wunsch algorithm [2] with identity scoring is used to align the structure sequence with the alignment sequence. Although slower than the automatic-association method, this approach will yield the optimal alignment even in those rare cases where automatic association fails (such as when the alignment sequence has an internal gap where the structure sequence does not).

If the sequence names are based on PDB identifiers [3] (for example, in alignments downloaded from HOMSTRAD [4]), the structures can be fetched over the internet from the PDB and opened automatically, instead of explicitly by the user. Similarly, if the sequence names are based on SCOP [5, 6] domain identifiers, the domain structures can be fetched from ASTRAL [7] and opened automatically.

Association permits many types of sequence-structure crosstalk, including the following: selections made with the mouse in the sequence are highlighted in the structure, and vice versa; the structure residue number is displayed when the cursor is placed over a residue in the sequence; and structures can be matched based on the sequence alignment. By default, structure matching uses the alpha-carbon pairs corresponding to every column in the alignment (where neither associated sequence has a gap) in a least-squares fit. Alternatives include using only columns highlighted by the user, or columns with high conservation. The fit can be improved iteratively by pruning alpha-carbon pairs that are not well superimposed. In each cycle, the atom pairs removed are either the 10% farthest apart of all pairs or the 50% farthest apart of all pairs exceeding a specified cutoff distance, whichever is fewer. Iteration allows the best-matching regions to govern the fit and conformationally dissimilar regions like flexible loops to be excluded, even though they may be aligned in the sequence alignment. While this matching is inherently pairwise, a multiple superposition can be achieved by using a consistent reference structure, for example, by matching B to A and C to A. Match statistics are reported in the Chimera Reply Log, which can be opened from the Favorites menu. The matched structures can be saved as PDB or Mol2 files.

A unique feature of Multalign Viewer is the treatment of headers, annotations that appear above the sequences in an alignment. Header information is automatically propagated as a residue attribute to any associated structures. If the header is numerical (shown above the alignment as a histogram), associated structures can be colored by the attribute value and/or shown as a "worm" with thickness scaled by the attribute value, using Chimera's Render by Attribute extension.

Figure 1 shows a structure colored by the values in the Conservation header. This header is present by default. Sophisticated methods for calculating conservation are provided by the AL2CO program of Pei and Grishin [8]: entropy-based, variance-based, or sum of pairs, with or without sequence weighting. Any number of additional headers can be defined arbitrarily by reading in a simple text file. Existing headers, including Conservation, can be saved into the same type of text file. After a header is loaded, it is displayed above the alignment (although it can be hidden if desired) and is available as an attribute of residues in any associated structures. Header information that consists of only a single character or digit per column could also be read in as part of an alignment in Stockholm format. The header file format, however, allows use of multiple-digit numbers: values ranging from large negative to large positive are transformed for histogram display (and transformed back into the original numbers if written to a file). The header mechanism allows user-calculated values to be incorporated into an alignment and visualized on structures without Chimera code development.

Figure 1
figure 1

Protein structure and associated sequence alignment. The structure of proclavaminate amidino hydrolase [PDB:1gq6] and the seed alignment from Pfam [33] for its family. Only a portion of the alignment is depicted. One chain of the trimer, shown as a ribbon, is associated with the first sequence in the alignment. The other two chains are shown as light blue backbone traces. The ribbon is colored from blue to pink to yellow with increasing conservation. Gray ribbon segments represent residues in columns for which conservation was not calculated due to a high proportion of gaps (0.5 or higher). Conservation values, also shown as histogram bars above the alignment, were obtained with the entropy-based measure in AL2CO [8] and "independent counts" weighting. Active site ions are shown in cyan. Residues in the structure that are completely conserved in the alignment have their side chains displayed and are indicated with blue boxes on the alignment. The part of the alignment that is shown includes conserved (boxed) ion-binding residues in a loop to the lower right of the ions. Highly conserved residues are primarily involved in the active site or inter-subunit interactions. Residues in the protein core are moderately conserved. In the sequence alignment, Clustal X coloring is used for the residue one-letter codes. The alignment part of the figure was exported directly from Multalign Viewer as Encapsulated PostScript.

The font size, text wrapping, and residue letter coloring can be adjusted in Multalign Viewer's preferences. Minor editing can be performed. Alignments or parts of alignments can be written out in any of the formats that can be read, with optional removal of all-gap columns. The sequence window contents can also be saved as an Encapsulated PostScript file for publication.

There are many additional features, including searching for a particular sub-sequence or PROSITE [9] pattern, display of secondary structure elements on the alignment, calculation of pairwise percent identities, and superposition assessment by generating a "closeness of fit" residue attribute. The state of Multalign Viewer is included in saved Chimera sessions. A user can save a session, exit from Chimera, and later resume work after restoring the session in Chimera.

MatchMaker

Most structural comparisons require the structures to be superimposed in some sensible way. A user may have a collection of structures to be compared, but no pre-existing sequence alignment to govern matching. The MatchMaker extension of Chimera constructs pairwise sequence alignments and uses them to superimpose the structures. The sequence alignment(s) can be kept hidden or opened in Multalign Viewer. As in structure matching with Multalign Viewer, the fit can be improved iteratively by pruning residue pairs far apart in space, match statistics are reported in the Chimera Reply Log, and a multiple superposition can be achieved by using a consistent reference structure. MatchMaker can be run from its graphical interface or from the Chimera command line.

The standard Needleman-Wunsch [2] and Smith-Waterman [10] algorithms are available for producing global and local sequence alignments, respectively. The chains to match can be specified explicitly, or MatchMaker can identify the best-matching chains based on alignment scores. Alignment scores can include residue similarity, secondary structure information, and gap penalties:

Residue similarity

Any of several common substitution matrices (BLOSUM [11] or PAM [12]) can be used.

Secondary structure

This contribution is analogous to residue similarity, but instead of residue types, the values depend on what type of secondary structure the residues fall within: helix, strand, or other.

Gap penalties

Alignment scores can be penalized for opening and extending gaps. When secondary structure scoring is used, there can be different penalties for opening gaps within different types of secondary structure.

The default settings are to use the Needleman-Wunsch algorithm with BLOSUM-62 and 30% weighting of the secondary structure term (thus 70% weighting of the residue similarity term). These settings perform well in many situations, but users can easily adjust these parameters, as well as the gap penalties and secondary structure matrix values, via the graphical interface. Secondary structure scoring can be turned off or its weight adjusted with a slider. Without secondary structure scoring, the method collapses to purely standard protocols for sequence alignment and scoring.

MatchMaker originally did not use secondary structure information. However, we often evaluated its performance by showing secondary structure on the sequence alignment, begging the question of why such information was not used directly. Using secondary structure extends the applicability of MatchMaker to more distantly related proteins, where purely sequence-based methods either cannot achieve a correct alignment, or can achieve a correct alignment, but only with a narrow set of parameters that may be hard to identify.

For example, enolase [PDB:4enl] and mandelate racemase [PDB:2mnr] are homologous but share less than 20% identity; common features include three metal-binding residues in the active site [13]. MatchMaker with default settings superimposes the structures correctly. In the sequence alignment, two of the three metal-binding residues are paired correctly and the third is offset by one position. Except for slight changes in the offset of the third metal-binding residue, this result is robust to changes in the weight of the secondary structure term (5–100%) or switches to other matrices, except PAM-40. Without secondary structure scoring, only the BLOSUM-35–45 matrices yield roughly correct superpositions, but with the active site residues poorly superimposed in space and incorrectly paired in the sequence alignments. Data for additional pairs are presented below, in the section on matching distantly related proteins.

Fit iteration does not change the sequence alignment; it just prunes columns of the alignment from the least-squares fit of the structures. Thus, the requirement for success with MatchMaker is merely that enough columns in the sequence alignment are structurally correct to dominate the initial superposition. Pruning during iteration will then exclude the "wrong" positions, yielding a correct superposition based on fitting the remaining pairs. Because relatively few pairs may remain at this stage, MatchMaker alone does not yield a full set of residue equivalences between structures. Residue equivalences can be obtained using Match -> Align, described next.

Match -> Align

Given a superimposed set of two or more protein structures, Match -> Align constructs a corresponding sequence alignment. It does not matter how the input superposition was generated; it could have been created interactively, or with a tool in Chimera such as MatchMaker, or with some other program. Residue types are not used, only the spatial proximities of alpha-carbons. The user specifies a cutoff distance and a column inclusion criterion: whether a residue must be within the cutoff distance of at least one other residue in the column or all other residues in the column. Structures related by circular permutation can be accommodated with sequence doubling. Match -> Align determines if sequence doubling is needed and if so, which sequence(s) should be doubled.

In the pairwise case, a dynamic programming algorithm is used to determine the sequence alignment that best represents the structural alignment. The score for aligning a pair of residues is (cutoff – distance) for distances no greater than the cutoff and -1 for distances greater than the cutoff. A gap penalty of zero is used so that spatial proximity overrules adjacency in sequence.

In the case of more than two structures, heuristics are required to render the problem tractable. For each pair of chains, all residue-residue pairings or "links" within the cutoff distance are identified. Links that cross when the sequences are laid out in parallel are removed, starting with the link with the most crossings, until no links between the pair cross. Alignment columns are then assembled and merged starting with the shortest-distance links, with each new addition checked for internal consistency and whether distances to other column members meet the column inclusion criterion.

The resulting sequence alignment is shown with Multalign Viewer and can be saved in various formats from that tool.

Calculation time scales approximately as N3 with the number of models (Figure S1 [see supplementary.doc]).

Matching distantly related proteins

Superpositions can be evaluated using the number of residues paired (N) and the corresponding root-mean-square deviation (RMSD). Since there is always a trade-off between higher N and lower RMSD, little can be said about a comparison where one superposition has both values higher or both lower than another. In fact, many N/RMSD pairs can describe the same superposition. For a given pair of structures, however, a superposition with both higher N and lower RMSD is clearly better.

Obtaining such data provides an example of how the sequence/structure tools in Chimera work together. Once the structures have been opened in Chimera, MatchMaker can be called from the menu or used via a command to superimpose them. The sequence alignment from MatchMaker could be shown with Multalign Viewer, but in the current situation, this would not be used. Information on the final (pruned) number of pairs and alpha-carbon RMSD is sent to the status line and Chimera Reply Log. As explained above, relatively few pairs may be used in MatchMaker's final fit, so Match -> Align would then be called from the menu to generate a full set of equivalences between the two structures, in the form of a sequence alignment. This sequence alignment is automatically shown with Multalign Viewer. Structure matching on all aligned positions would then be called from Multalign Viewer's menu to obtain an RMSD for the set of equivalent pairs. This procedure may sound elaborate, but actually takes just a few seconds.

Fischer and coworkers [14] collected a set of same-fold, low-identity protein pairs and rated their difficulty for sequence alignment and fold recognition. Table 1 shows N/RMSD data for the ten pairs rated most difficult. Superpositions were generated using MatchMaker with default alignment scoring, scoring without secondary structure, and scoring with only secondary structure, that is, 100% weighting of the secondary structure term.

Table 1 Chimera results for difficult structure pairs

Based on visual inspection and the results in Table 1, MatchMaker with default scoring superimposes nine of the ten pairs correctly. The fit of pair 8 appears close, but is likely wrong in that it implies a circular permutation of one protein relative to the other (shown in Figure 2 and discussed further in the Comparisons section). Without secondary structure scoring, none of the superpositions are correct; no result was obtained for pair 1 because iteration halted when the number of residue pairs fell below four, and the other nine pairs were superimposed incorrectly. With secondary structure scoring alone, the superpositions of seven pairs are grossly correct, but most of the fits are not as good as with default scoring. Pair 8 was also matched correctly, lacking the circular permutation obtained with default scoring, but pairs 4 and 7 were matched incorrectly.

Figure 2
figure 2

Comparison of matched orientations (pair 8). Comparison of matched orientations from MatchMaker (default settings) and CE [26] (web server [34] with default settings). Each matched structure [PDB:4fgf] is rainbow-colored from blue at the N-terminus to red at the C-terminus. The reference structure [PDB:1tie] is shown in tan on the right.

Not surprisingly, secondary structure scoring makes MatchMaker sensitive to secondary structure assignments. We have found that recalculating secondary structure with the Kabsch and Sander algorithm [15] (as implemented within Chimera) instead of using pre-existing assignments yields very similar or improved results, depending on the pair (Table S1 [see supplementary.doc]). This option is on by default in MatchMaker. The improvement is likely due (at least in part) to the use of consistent criteria among the structures being matched. Secondary structure assignments in the input PDB files may have been generated with different criteria for different structures.

One might argue that the default matrix, BLOSUM-62, is not appropriate for such divergent proteins. To address this issue, analogous tests were performed with BLOSUM-30 instead (Table S2 [see supplementary.doc]). With secondary structure scoring (default weight of 30%), BLOSUM-30 superimposed all pairs correctly except pair 5. Thus, when combined with secondary structure scoring, BLOSUM-30 and BLOSUM-62 each correctly superimpose nine of the ten pairs. Without secondary structure scoring, BLOSUM-30 yielded only roughly correct matches for pairs 7 and 9, and incorrect matches for the others. This is better than the zero correct matches obtained with BLOSUM-62 alone, but still quite poor. Secondary structure scoring helps to generate better fits than can be obtained with sequence methods alone and decreases MatchMaker's sensitivity to the choice of substitution matrix.

Interestingly, end results are almost identical when the Smith-Waterman algorithm (local alignment) is used in MatchMaker instead of the default Needleman-Wunsch algorithm (global alignment) (Table S3 [see supplementary.doc]). Apparently, the pruning of pairs during iteration leads to use of the same or nearly the same set of positions in the final fit.

MatchMaker's purpose is to provide correct and useful superpositions for interactive study in a wide range of research situations (from closely related to broader groups of proteins, with varying amounts of sequence and structure data available), and to do so quickly and conveniently. It does not produce any significance metric and is not intended for remote homology detection. We envisioned it would be used on structures above the "twilight zone" of sequence identity, including trivial cases like different conformations of a given protein or mutants versus wild-type proteins. The ability to correctly match distantly related proteins is an added and somewhat unforeseen benefit.

Comparisons with other programs

Several programs overlap in function with Chimera's Multalign Viewer. Alone or in combination with partner visualization programs, these generally allow adjustments to the sequence and structure displays and simple crosstalk between sequence and structure. Some of the programs allow alignment editing and superposition of structures based on the sequence alignment. ModView [16] and its stand-alone successor Friend [17] also integrate phylogenetic information such as dendrograms. ViTO [18] displays alignment insertions and deletions on structures and reports threading energies. STRAP [19] is designed to handle large numbers of sequences; structure visualization is provided by a partner program such as PyMOL [20] or Visual Molecular Dynamics (VMD) [21]. ModView [16] and STRAP [19] can be used as Web plug-ins. Cn3D [22] is a web plug-in distributed as part of Entrez [23]. STING [24, 25] is a web plug-in that can display pairwise alignments from Combinatorial Extension [26] (CE, discussed further below); many types of structure-related data are shown on the sequence alignment, and Jmol [27] is used to display the structures.

Multalign Viewer cannot be used as a Web plug-in. Other disadvantages, which we plan to address in the future, are that editing capabilities are limited and there is no interaction with phylogenetic information such as dendrograms. Although there is no hard limit on the number of sequences that can be handled, Chimera uses more memory per sequence and structure than many other programs. Advantages of Multalign Viewer include the ability to add arbitrary sequence annotations, automatic propagation of sequence annotations to associated structures, sophisticated options for calculating conservation, and the ability to wrap alignment text instead of presenting it as a horizontal bar.

It is beyond the scope of this paper to discuss the many existing methods for protein superposition. For comparison with MatchMaker, we will mention a few that are integrated with programs with broader sequence/structure visualization capabilities. The align command in PyMOL [20] is similar to MatchMaker without the secondary structure term. It generates a sequence alignment and fits structures accordingly, with or without fit iteration. The Multiple Alignment plug-in [28] to VMD [21] uses STAMP [29]. STAMP starts with approximate matches that can be generated by sequence methods or by scanning segments of a protein against the others for structural similarity. It then refines the fits and determines a sensible order in which to add successive structures to a multiple superposition. Cn3D [22] aligns structures using VAST (Vector Alignment Search Tool) [30], which pairs secondary structure elements of similar types, orientations, and connectivities. The program Friend [17] can superimpose structures with TOPOFIT [31] or Combinatorial Extension (CE) [26]. STRAP [19] can use CE [26] or an unpublished method by Goede. TOPOFIT, CE, and the Goede method are quite different from each other, but they all use structure information, not sequence (although residue identity can be used in the optimization stage of CE).

To our knowledge, only MatchMaker can use both sequence and structure information in the initial round of matching. Methods that use only sequence information often fail when proteins are highly divergent. Conversely, methods that use only structure are discarding any signal present in the sequences.

In practice, superpositions of low-identity pairs from Chimera are comparable to those from structure-based methods. Table 2 shows results obtained with Chimera, TOPOFIT [31], and CE [26] for the same pairs of structures as in Table 1. In terms of N and RMSD, the Chimera results fall between those of TOPOFIT and CE for all pairs except pair 8.

Table 2 Results from different programs for difficult structure pairs

The agreement between Chimera's MatchMaker and CE is more evident when a consistent method is used to obtain equivalences. Columns Chimera and CE/MA in Table 2 show data for the equivalences determined by Match -> Align with cutoff 5.0 angstroms. Only pairs 8 and 10 show major differences. As mentioned above, the superposition of pair 8 from MatchMaker implies a circular permutation of one protein relative to the other (Figure 2). Allowing for circular permutation when using Match -> Align on this superposition yields 105 pairs matched with 2.3 angstroms RMSD. The non-permuted alignment from Match -> Align for the CE superposition, however, also yields 105 pairs but with a lower RMSD (Table 2), further evidence that the CE superposition is the correct one. The opposite is true for pair 10: in the CE superposition, a central sheet is shifted over by one strand relative to the correct match. Importantly, default settings were used in Chimera; it is likely that performance could be improved with pair-specific parameter tuning or with additional cycles of matching, pruning, and creating another sequence alignment.

The ratio of sequence to structure information used by MatchMaker is adjustable; the ratio most appropriate for a given problem depends on the divergence of the proteins and the intended use of the results. However, results are generally robust to a wide range of parameter settings, and there should be little need for hunting down an optimal set of parameters. The combined sequence-structure score is similar in spirit to that used in STACCATO [32] for a different purpose (see below). Disadvantages of MatchMaker are that it is inherently pairwise and does not provide guidance on which structure should be used as the reference for overlaying multiple structures.

Few programs exist to derive a sequence alignment from an arbitrary pre-existing superposition. The only one we know of besides Match -> Align is STACCATO [32]. The methods are very different, however. STACCATO uses a unique sequence-structure score with contributions from residue similarity, residue secondary structure environment, and spatial proximity. In Chimera, the first two types of information are used by MatchMaker to fit the structures, but only the third, spatial proximity, is used by Match -> Align to determine equivalences. STACCATO can use a distance cutoff with an "all others" column inclusion criterion, but it can also operate without a cutoff; the score will still favor the alignment in sequence of residues close in space.

The separation of structure matching from generation of a structure-based sequence alignment is important when a user has already obtained the desired fit using protein-specific knowledge, such as by matching a constellation of important active site residues, or by fitting using only the atoms of a bound ligand or cofactor. In such cases, it would defeat the purpose to use a global structure-based superposition program to produce a sequence alignment, as that would simultaneously alter the structural fit. Separation of these two tasks also makes it more obvious that many different sequence alignments are consistent with a given structural superposition; users can vary the column inclusion criterion and cutoff distance as appropriate for the intended purpose of the alignment and the divergence of the proteins under study.

The Chimera sequence/structure tools provide access to many parameter settings via graphical interfaces. A further advantage, apart from their individual merits, is the convenience of having the tools work together within a single program. Advantages relating to Chimera as a whole are a broad feature set for structure analysis, detailed and searchable documentation, program extensibility, and continuing development. Finally, although Chimera has many features, it is not meant to be a closed system; it can read many common file formats. This allows researchers to use superpositions or sequence alignments from outside programs or databases in lieu of one of Chimera's similar tools, while still benefiting from features of the other tools discussed.

Future directions

We have many ideas for future developments; some of the more concrete and near-term issues are mentioned here.

Editing in Multalign Viewer is currently limited to shifting highlighted blocks of sequence to create, extend, or remove gaps; residues cannot be changed, and they can only be deleted by rewriting a new file minus those residues. We plan to allow entire sequences and alignment columns to be deleted without new file creation.

We envision reading phylogenetic data along with an alignment and displaying the tree and sequences side by side. Nodes in the alignment would be collapsible to representative or consensus sequences, and analyses such as conservation calculations could be applied to only the members of a node.

Although several ways to calculate conservation are already included and users can create their own header information by loading a text file, we plan to make headers even more powerful by allowing users to define their own header functions. While loading a header file places static values in the header line, values produced by a function can be recomputed for different alignments or as the alignment is changed by editing. We will also allow headers to be graphical representations, such as cylinders and thick arrows to symbolize stretches of helix and strand. Another option will be to show residue numbers at the ends of lines.

In principle, the sequence-structure tools in Chimera can be used on nucleic acids, but little attention has been paid to this application. MatchMaker has a DNA matrix, but it would be helpful to add a matrix that works with RNA.

Chimera as a whole will benefit from ongoing efforts to improve its speed and memory usage.

Conclusion

Chimera includes tools for integrating protein sequence and structure information. The Multalign Viewer tool displays internally and externally generated sequence alignments with customizable layout and coloring. Structures opened in Chimera are automatically associated with sequences in the alignment, as appropriate. Association enables matching of structures according to the sequence alignment, display of alignment-related data such as conservation on the structures, and display of structure-related data on the sequence alignment. In the absence of a pre-existing alignment, the MatchMaker tool constructs a new alignment and matches structures accordingly. The alignment score includes secondary structure information, extending the usefulness of MatchMaker to distantly related proteins. The Match -> Align tool creates sequence alignments of two or more proteins that have already been superimposed, using only the spatial proximities of their alpha-carbons.

Advantages of using Chimera for sequence/structure research include a rich set of features co-existing in a single program, certain unique methods, facile integration of user data, access to the broader visualization and analysis capabilities of Chimera, program extensibility, detailed documentation, and continuing development.

Availability and requirements

Project name: UCSF Chimera

Project home page: http://www.cgl.ucsf.edu/chimera

Operating systems: Microsoft Windows, Linux, Apple Mac OS X, SGI IRIX, and HP Tru64 Unix

Programming language: Python, C++

License: Chimera is free to academic and non-profit users, subject to an online license agreement. Commercial use requires a fee and a separate, written license agreement (interested parties should contact tef@cgl.ucsf.edu). The distribution bundle includes user documentation, executables, and all Python code. The full source code including C++ files is also available for download.

Abbreviations

UCSF:

University of California San Francisco

GUI:

graphical user interface

GCG MSF:

Genetics Computing Group Multiple Sequence Format

GCG RSF:

Genetics Computing Group Rich Sequence Format

NBRF:

National Biomedical Research Foundation

PIR:

Protein Information Resource

PDB:

Protein Data Bank

SCOP:

Structural Classification of Proteins

RMSD:

root-mean-square deviation

VMD:

Visual Molecular Dynamics

STAMP:

STructural Alignment of Multiple Proteins

VAST:

Vector Alignment Search Tool

CE:

Combinatorial Extension

STACCATO:

STructural sequence Alignment, Correspondence and Conservation Analysis TOol.

References

  1. Pettersen EF, Goddard TD, Huang CC, Couch GS, Greenblatt DM, Meng EC, Ferrin TE: UCSF Chimera - A visualization system for exploratory research and analysis. J Comput Chem 2004, 25(13):1605–1612. 10.1002/jcc.20084

    Article  CAS  PubMed  Google Scholar 

  2. Needleman SB, Wunsch CD: A general method applicable to the search for similarities in the amino acid sequence of two proteins. J Mol Biol 1970, 48(3):443–453. 10.1016/0022-2836(70)90057-4

    Article  CAS  PubMed  Google Scholar 

  3. Berman HM, Westbrook J, Feng Z, Gilliland G, Bhat TN, Weissig H, Shindyalov IN, Bourne PE: The Protein Data Bank. Nucleic Acids Res 2000, 28(1):235–242. 10.1093/nar/28.1.235

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Stebbings LA, Mizuguchi K: HOMSTRAD: recent developments of the Homologous Protein Structure Alignment Database. Nucleic Acids Res 2004, 32(Database issue):D203–7. 10.1093/nar/gkh027

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Andreeva A, Howorth D, Brenner SE, Hubbard TJ, Chothia C, Murzin AG: SCOP database in 2004: refinements integrate structure and sequence family data. Nucleic Acids Res 2004, 32: D226–9. 10.1093/nar/gkh039

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Murzin AG, Brenner SE, Hubbard T, Chothia C: SCOP: a structural classification of proteins database for the investigation of sequences and structures. J Mol Biol 1995, 247(4):536–540. 10.1006/jmbi.1995.0159

    CAS  PubMed  Google Scholar 

  7. Chandonia JM, Hon G, Walker NS, Lo Conte L, Koehl P, Levitt M, Brenner SE: The ASTRAL Compendium in 2004. Nucleic Acids Res 2004, 32(Database issue):D189–92. 10.1093/nar/gkh034

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Pei J, Grishin NV: AL2CO: calculation of positional conservation in a protein sequence alignment. Bioinformatics 2001, 17(8):700–712. 10.1093/bioinformatics/17.8.700

    Article  CAS  PubMed  Google Scholar 

  9. Sigrist CJ, Cerutti L, Hulo N, Gattiker A, Falquet L, Pagni M, Bairoch A, Bucher P: PROSITE: a documented database using patterns and profiles as motif descriptors. Brief Bioinform 2002, 3(3):265–274. 10.1093/bib/3.3.265

    Article  CAS  PubMed  Google Scholar 

  10. Smith TF, Waterman MS: Identification of common molecular subsequences. J Mol Biol 1981, 147(1):195–197. 10.1016/0022-2836(81)90087-5

    Article  CAS  PubMed  Google Scholar 

  11. Henikoff S, Henikoff JG: Amino acid substitution matrices from protein blocks. Proc Natl Acad Sci U S A 1992, 89(22):10915–10919. 10.1073/pnas.89.22.10915

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Dayhoff MO, Schwartz RM, Orcutt BC: A model of evolutionary change in proteins. In Atlas of Protein Sequence and Structure. Volume 5(3). Edited by: Dayhoff MO. Washington, DC, National Biomedical Research Foundation; 1978:345–352.

    Google Scholar 

  13. Babbitt PC, Hasson MS, Wedekind JE, Palmer DR, Barrett WC, Reed GH, Rayment I, Ringe D, Kenyon GL, Gerlt JA: The enolase superfamily: a general strategy for enzyme-catalyzed abstraction of the alpha-protons of carboxylic acids. Biochemistry 1996, 35(51):16489–16501. 10.1021/bi9616413

    Article  CAS  PubMed  Google Scholar 

  14. Fischer D, Elofsson A, Rice D, Eisenberg D: Assessing the performance of fold recognition methods by means of a comprehensive benchmark. Pac Symp Biocomput 1996, 300–318.

    Google Scholar 

  15. Kabsch W, Sander C: Dictionary of protein secondary structure: pattern recognition of hydrogen-bonded and geometrical features. Biopolymers 1983, 22(12):2577–2637. 10.1002/bip.360221211

    Article  CAS  PubMed  Google Scholar 

  16. Ilyin VA, Pieper U, Stuart AC, Marti-Renom MA, McMahan L, Sali A: ModView, visualization of multiple protein sequences and structures. Bioinformatics 2003, 19(1):165–166. 10.1093/bioinformatics/19.1.165

    Article  CAS  PubMed  Google Scholar 

  17. Abyzov A, Errami M, Leslin CM, Ilyin VA: Friend, an integrated analytical front-end application for bioinformatics. Bioinformatics 2005, 21(18):3677–3678. 10.1093/bioinformatics/bti602

    Article  CAS  PubMed  Google Scholar 

  18. Catherinot V, Labesse G: ViTO: tool for refinement of protein sequence-structure alignments. Bioinformatics 2004, 20(18):3694–3696. 10.1093/bioinformatics/bth429

    Article  CAS  PubMed  Google Scholar 

  19. Gille C, Lorenzen S, Michalsky E, Frommel C: KISS for STRAP: user extensions for a protein alignment editor. Bioinformatics 2003, 19(18):2489–2491. 10.1093/bioinformatics/btg354

    Article  CAS  PubMed  Google Scholar 

  20. DeLano WL: PyMOL.DeLano Scientific LLC; [http://pymol.sourceforge.net]

  21. Humphrey W, Dalke A, Schulten K: VMD: visual molecular dynamics. J Mol Graph 1996, 14(1):33–8, 27–8. 10.1016/0263-7855(96)00018-5

    Article  CAS  PubMed  Google Scholar 

  22. Wang Y, Geer LY, Chappey C, Kans JA, Bryant SH: Cn3D: sequence and structure views for Entrez. Trends Biochem Sci 2000, 25(6):300–302. 10.1016/S0968-0004(00)01561-9

    Article  CAS  PubMed  Google Scholar 

  23. Wheeler DL, Barrett T, Benson DA, Bryant SH, Canese K, Chetvernin V, Church DM, DiCuccio M, Edgar R, Federhen S, Geer LY, Helmberg W, Kapustin Y, Kenton DL, Khovayko O, Lipman DJ, Madden TL, Maglott DR, Ostell J, Pruitt KD, Schuler GD, Schriml LM, Sequeira E, Sherry ST, Sirotkin K, Souvorov A, Starchenko G, Suzek TO, Tatusov R, Tatusova TA, Wagner L, Yaschenko E: Database resources of the National Center for Biotechnology Information. Nucleic Acids Res 2006, 34(Database issue):D173–80. 10.1093/nar/gkj158

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  24. Neshich G, Borro LC, Higa RH, Kuser PR, Yamagishi ME, Franco EH, Krauchenco JN, Fileto R, Ribeiro AA, Bezerra GB, Velludo TM, Jimenez TS, Furukawa N, Teshima H, Kitajima K, Bava A, Sarai A, Togawa RC, Mancini AL: The Diamond STING server. Nucleic Acids Res 2005, 33(Web Server issue):W29–35. 10.1093/nar/gki397

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  25. Higa RH, Togawa RC, Montagner AJ, Palandrani JC, Okimoto IK, Kuser PR, Yamagishi ME, Mancini AL, Neshich G: STING Millennium Suite: integrated software for extensive analyses of 3d structures of proteins and their complexes. BMC Bioinformatics 2004, 5: 107. 10.1186/1471-2105-5-107

    Article  PubMed Central  PubMed  Google Scholar 

  26. Shindyalov IN, Bourne PE: Protein structure alignment by incremental combinatorial extension (CE) of the optimal path. Protein Eng 1998, 11(9):739–747. 10.1093/protein/11.9.739

    Article  CAS  PubMed  Google Scholar 

  27. Jmol[http://jmol.sourceforge.net]

  28. Eargle J, Wright D, Luthey-Schulten Z: Multiple Alignment of protein structures and sequences for VMD. Bioinformatics 2006, 22(4):504–506. 10.1093/bioinformatics/bti825

    Article  CAS  PubMed  Google Scholar 

  29. Russell RB, Barton GJ: Multiple protein sequence alignment from tertiary structure comparison: assignment of global and residue confidence levels. Proteins 1992, 14(2):309–323. 10.1002/prot.340140216

    Article  CAS  PubMed  Google Scholar 

  30. Gibrat JF, Madej T, Bryant SH: Surprising similarities in structure comparison. Curr Opin Struct Biol 1996, 6(3):377–385. 10.1016/S0959-440X(96)80058-3

    Article  CAS  PubMed  Google Scholar 

  31. Ilyin VA, Abyzov A, Leslin CM: Structural alignment of proteins by a novel TOPOFIT method, as a superimposition of common volumes at a topomax point. Protein Sci 2004, 13(7):1865–1874. 10.1110/ps.04672604

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  32. Shatsky M, Nussinov R, Wolfson HJ: Optimization of multiple-sequence alignment based on multiple-structure alignment. Proteins 2005, 62(1):209–217. 10.1002/prot.20665

    Article  Google Scholar 

  33. Bateman A, Coin L, Durbin R, Finn RD, Hollich V, Griffiths-Jones S, Khanna A, Marshall M, Moxon S, Sonnhammer EL, Studholme DJ, Yeats C, Eddy SR: The Pfam protein families database. Nucleic Acids Res 2004, 32(Database issue):D138–41. 10.1093/nar/gkh121

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  34. CE server[http://cl.sdsc.edu/ce/ce_align.html]

  35. TOPOFIT server[http://mozart.bio.neu.edu/topofit/topofit_email.html]

Download references

Acknowledgements

We are grateful to John H. Morris for comments on this manuscript. UCSF Chimera development is funded by the NIH National Center for Research Resources (grant P41-RR01081).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Thomas E Ferrin.

Additional information

Authors' contributions

EFP designed and implemented the Chimera extensions described in this work, with major input from ECM. ECM wrote the user documentation, generated the results presented herein, and wrote the paper, with major input from EFP. Along with EFP, GSC, CCH, and TEF designed and implemented the Chimera system. All authors have participated in discussions about this manuscript and the tools described.

Elaine C Meng, Eric F Pettersen contributed equally to this work.

Electronic supplementary material

12859_2006_1078_MOESM1_ESM.doc

Additional File 1: Supplementary data. Default parameters in Chimera version 1.2199, MatchMaker results with different parameter settings (Tables S1–S3), scaling of Match -> Align computation time (Figure S1). (DOC 136 KB)

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Meng, E.C., Pettersen, E.F., Couch, G.S. et al. Tools for integrated sequence-structure analysis with UCSF Chimera. BMC Bioinformatics 7, 339 (2006). https://doi.org/10.1186/1471-2105-7-339

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-7-339

Keywords