2 * Jalview - A Sequence Alignment Editor and Viewer (Version 2.8)
3 * Copyright (C) 2012 J Procter, AM Waterhouse, LM Lui, J Engelhardt, G Barton, M Clamp, S Searle
5 * This file is part of Jalview.
7 * Jalview is free software: you can redistribute it and/or
8 * modify it under the terms of the GNU General Public License
9 * as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version.
11 * Jalview is distributed in the hope that it will be useful, but
12 * WITHOUT ANY WARRANTY; without even the implied warranty
13 * of MERCHANTABILITY or FITNESS FOR A PARTICULAR
14 * PURPOSE. See the GNU General Public License for more details.
16 * You should have received a copy of the GNU General Public License along with Jalview. If not, see <http://www.gnu.org/licenses/>.
18 package jalview.analysis;
22 import jalview.datamodel.*;
23 import jalview.util.*;
26 * Routines for manipulating the order of a multiple sequence alignment TODO:
27 * this class retains some global states concerning sort-order which should be
28 * made attributes for the caller's alignment visualization. TODO: refactor to
29 * allow a subset of selected sequences to be sorted within the context of a
30 * whole alignment. Sort method template is: SequenceI[] tobesorted, [ input
31 * data mapping to each tobesorted element to use ], Alignment context of
32 * tobesorted that are to be re-ordered, boolean sortinplace, [special data - ie
33 * seuqence to be sorted w.r.t.]) sortinplace implies that the sorted vector
34 * resulting from applying the operation to tobesorted should be mapped back to
35 * the original positions in alignment. Otherwise, normal behaviour is to re
36 * order alignment so that tobesorted is sorted and grouped together starting
37 * from the first tobesorted position in the alignment. e.g. (a,tb2,b,tb1,c,tb3
38 * becomes a,tb1,tb2,tb3,b,c)
40 public class AlignmentSorter
43 * todo: refactor searches to follow a basic pattern: (search property, last
44 * search state, current sort direction)
46 static boolean sortIdAscending = true;
48 static int lastGroupHash = 0;
50 static boolean sortGroupAscending = true;
52 static AlignmentOrder lastOrder = null;
54 static boolean sortOrderAscending = true;
56 static NJTree lastTree = null;
58 static boolean sortTreeAscending = true;
61 * last Annotation Label used by sortByScore
63 private static String lastSortByScore;
65 private static boolean sortByScoreAscending = true;
68 * compact representation of last arguments to SortByFeatureScore
70 private static String lastSortByFeatureScore;
72 private static boolean sortByFeatureScoreAscending = true;
74 private static boolean sortLengthAscending;
77 * Sort by Percentage Identity w.r.t. s
84 * sequences from align that are to be sorted.
86 public static void sortByPID(AlignmentI align, SequenceI s,
89 sortByPID(align, s, tosort, 0, -1);
93 * Sort by Percentage Identity w.r.t. s
100 * sequences from align that are to be sorted.
102 * start column (0 for beginning
105 public static void sortByPID(AlignmentI align, SequenceI s,
106 SequenceI[] tosort, int start, int end)
108 int nSeq = align.getHeight();
110 float[] scores = new float[nSeq];
111 SequenceI[] seqs = new SequenceI[nSeq];
113 for (int i = 0; i < nSeq; i++)
115 scores[i] = Comparison.PID(align.getSequenceAt(i)
116 .getSequenceAsString(), s.getSequenceAsString());
117 seqs[i] = align.getSequenceAt(i);
120 QuickSort.sort(scores, 0, scores.length - 1, seqs);
122 setReverseOrder(align, seqs);
126 * Reverse the order of the sort
133 private static void setReverseOrder(AlignmentI align, SequenceI[] seqs)
135 int nSeq = seqs.length;
145 len = (nSeq + 1) / 2;
148 // NOTE: DO NOT USE align.setSequenceAt() here - it will NOT work
150 synchronized (asq = align.getSequences())
152 for (int i = 0; i < len; i++)
154 // SequenceI tmp = seqs[i];
155 asq.set(i, seqs[nSeq - i - 1]);
156 asq.set(nSeq - i - 1, seqs[i]);
162 * Sets the Alignment object with the given sequences
165 * Alignment object to be updated
167 * sequences as a vector
169 private static void setOrder(AlignmentI align, Vector tmp)
171 setOrder(align, vectorSubsetToArray(tmp, align.getSequences()));
175 * Sets the Alignment object with the given sequences
180 * sequences as an array
182 public static void setOrder(AlignmentI align, SequenceI[] seqs)
184 // NOTE: DO NOT USE align.setSequenceAt() here - it will NOT work
185 List<SequenceI> algn;
186 synchronized (algn = align.getSequences())
188 List<SequenceI> tmp = new ArrayList<SequenceI>();
190 for (int i = 0; i < seqs.length; i++)
192 if (algn.contains(seqs[i]))
199 // User may have hidden seqs, then clicked undo or redo
200 for (int i = 0; i < tmp.size(); i++)
202 algn.add(tmp.get(i));
208 * Sorts by ID. Numbers are sorted before letters.
211 * The alignment object to sort
213 public static void sortByID(AlignmentI align)
215 int nSeq = align.getHeight();
217 String[] ids = new String[nSeq];
218 SequenceI[] seqs = new SequenceI[nSeq];
220 for (int i = 0; i < nSeq; i++)
222 ids[i] = align.getSequenceAt(i).getName();
223 seqs[i] = align.getSequenceAt(i);
226 QuickSort.sort(ids, seqs);
230 setReverseOrder(align, seqs);
234 setOrder(align, seqs);
237 sortIdAscending = !sortIdAscending;
241 * Sorts by sequence length
244 * The alignment object to sort
246 public static void sortByLength(AlignmentI align)
248 int nSeq = align.getHeight();
250 float[] length = new float[nSeq];
251 SequenceI[] seqs = new SequenceI[nSeq];
253 for (int i = 0; i < nSeq; i++)
255 seqs[i] = align.getSequenceAt(i);
256 length[i] = (seqs[i].getEnd() - seqs[i].getStart());
259 QuickSort.sort(length, seqs);
261 if (sortLengthAscending)
263 setReverseOrder(align, seqs);
267 setOrder(align, seqs);
270 sortLengthAscending = !sortLengthAscending;
274 * Sorts the alignment by size of group. <br>
275 * Maintains the order of sequences in each group by order in given alignment
279 * sorts the given alignment object by group
281 public static void sortByGroup(AlignmentI align)
283 // MAINTAINS ORIGNAL SEQUENCE ORDER,
284 // ORDERS BY GROUP SIZE
285 Vector groups = new Vector();
287 if (groups.hashCode() != lastGroupHash)
289 sortGroupAscending = true;
290 lastGroupHash = groups.hashCode();
294 sortGroupAscending = !sortGroupAscending;
297 // SORTS GROUPS BY SIZE
298 // ////////////////////
299 for (SequenceGroup sg : align.getGroups())
301 for (int j = 0; j < groups.size(); j++)
303 SequenceGroup sg2 = (SequenceGroup) groups.elementAt(j);
305 if (sg.getSize() > sg2.getSize())
307 groups.insertElementAt(sg, j);
313 if (!groups.contains(sg))
315 groups.addElement(sg);
319 // NOW ADD SEQUENCES MAINTAINING ALIGNMENT ORDER
320 // /////////////////////////////////////////////
321 Vector seqs = new Vector();
323 for (int i = 0; i < groups.size(); i++)
325 SequenceGroup sg = (SequenceGroup) groups.elementAt(i);
326 SequenceI[] orderedseqs = sg.getSequencesInOrder(align);
328 for (int j = 0; j < orderedseqs.length; j++)
330 seqs.addElement(orderedseqs[j]);
334 if (sortGroupAscending)
336 setOrder(align, seqs);
340 setReverseOrder(align,
341 vectorSubsetToArray(seqs, align.getSequences()));
346 * Converts Vector to array. java 1.18 does not have Vector.toArray()
349 * Vector of SequenceI objects
351 * @return array of Sequence[]
353 private static SequenceI[] vectorToArray(Vector tmp)
355 SequenceI[] seqs = new SequenceI[tmp.size()];
357 for (int i = 0; i < tmp.size(); i++)
359 seqs[i] = (SequenceI) tmp.elementAt(i);
366 * Select sequences in order from tmp that is present in mask, and any
367 * remaining seqeunces in mask not in tmp
370 * thread safe collection of sequences
372 * thread safe collection of sequences
374 * @return intersect(tmp,mask)+intersect(complement(tmp),mask)
376 private static SequenceI[] vectorSubsetToArray(List<SequenceI> tmp,
377 List<SequenceI> mask)
379 ArrayList<SequenceI> seqs = new ArrayList<SequenceI>();
381 boolean[] tmask = new boolean[mask.size()];
383 for (i = 0; i < mask.size(); i++)
388 for (i = 0; i < tmp.size(); i++)
390 SequenceI sq = tmp.get(i);
391 idx = mask.indexOf(sq);
392 if (idx > -1 && tmask[idx])
399 for (i = 0; i < tmask.length; i++)
403 seqs.add(mask.get(i));
407 return seqs.toArray(new SequenceI[seqs.size()]);
411 * Sorts by a given AlignmentOrder object
416 * specified order for alignment
418 public static void sortBy(AlignmentI align, AlignmentOrder order)
420 // Get an ordered vector of sequences which may also be present in align
421 Vector tmp = order.getOrder();
423 if (lastOrder == order)
425 sortOrderAscending = !sortOrderAscending;
429 sortOrderAscending = true;
432 if (sortOrderAscending)
434 setOrder(align, tmp);
438 setReverseOrder(align, vectorSubsetToArray(tmp, align.getSequences()));
450 * @return DOCUMENT ME!
452 private static Vector getOrderByTree(AlignmentI align, NJTree tree)
454 int nSeq = align.getHeight();
456 Vector tmp = new Vector();
458 tmp = _sortByTree(tree.getTopNode(), tmp, align.getSequences());
460 if (tmp.size() != nSeq)
462 // TODO: JBPNote - decide if this is always an error
463 // (eg. not when a tree is associated to another alignment which has more
465 if (tmp.size() != nSeq)
467 addStrays(align, tmp);
470 if (tmp.size() != nSeq)
473 .println("WARNING: tmp.size()="
477 + " in getOrderByTree - tree contains sequences not in alignment");
485 * Sorts the alignment by a given tree
492 public static void sortByTree(AlignmentI align, NJTree tree)
494 Vector tmp = getOrderByTree(align, tree);
496 // tmp should properly permute align with tree.
497 if (lastTree != tree)
499 sortTreeAscending = true;
504 sortTreeAscending = !sortTreeAscending;
507 if (sortTreeAscending)
509 setOrder(align, tmp);
513 setReverseOrder(align, vectorSubsetToArray(tmp, align.getSequences()));
525 private static void addStrays(AlignmentI align, Vector seqs)
527 int nSeq = align.getHeight();
529 for (int i = 0; i < nSeq; i++)
531 if (!seqs.contains(align.getSequenceAt(i)))
533 seqs.addElement(align.getSequenceAt(i));
537 if (nSeq != seqs.size())
540 .println("ERROR: Size still not right even after addStrays");
554 * @return DOCUMENT ME!
556 private static Vector _sortByTree(SequenceNode node, Vector tmp,
557 List<SequenceI> seqset)
564 SequenceNode left = (SequenceNode) node.left();
565 SequenceNode right = (SequenceNode) node.right();
567 if ((left == null) && (right == null))
569 if (!node.isPlaceholder() && (node.element() != null))
571 if (node.element() instanceof SequenceI)
573 if (!tmp.contains(node.element())) // && (seqset==null ||
574 // seqset.size()==0 ||
575 // seqset.contains(tmp)))
577 tmp.addElement(node.element());
586 _sortByTree(left, tmp, seqset);
587 _sortByTree(right, tmp, seqset);
594 // Alignment.sortBy(OrderObj) - sequence of sequence pointer refs in
599 * recover the order of sequences given by the safe numbering scheme introducd
600 * SeqsetUtils.uniquify.
602 public static void recoverOrder(SequenceI[] alignment)
604 float[] ids = new float[alignment.length];
606 for (int i = 0; i < alignment.length; i++)
608 ids[i] = (new Float(alignment[i].getName().substring(8)))
612 jalview.util.QuickSort.sort(ids, alignment);
616 * Sort sequence in order of increasing score attribute for annotation with a
617 * particular scoreLabel. Or reverse if same label was used previously
620 * exact label for sequence associated AlignmentAnnotation scores to
623 * sequences to be sorted
625 public static void sortByAnnotationScore(String scoreLabel,
626 AlignmentI alignment)
628 SequenceI[] seqs = alignment.getSequencesArray();
629 boolean[] hasScore = new boolean[seqs.length]; // per sequence score
631 int hasScores = 0; // number of scores present on set
632 double[] scores = new double[seqs.length];
633 double min = 0, max = 0;
634 for (int i = 0; i < seqs.length; i++)
636 AlignmentAnnotation[] scoreAnn = seqs[i].getAnnotation(scoreLabel);
637 if (scoreAnn != null)
641 scores[i] = scoreAnn[0].getScore(); // take the first instance of this
645 max = min = scores[i];
666 return; // do nothing - no scores present to sort by.
668 if (hasScores < seqs.length)
670 for (int i = 0; i < seqs.length; i++)
674 scores[i] = (max + i + 1.0);
679 jalview.util.QuickSort.sort(scores, seqs);
680 if (lastSortByScore != scoreLabel)
682 lastSortByScore = scoreLabel;
683 setOrder(alignment, seqs);
687 setReverseOrder(alignment, seqs);
692 * types of feature ordering: Sort by score : average score - or total score -
693 * over all features in region Sort by feature label text: (or if null -
694 * feature type text) - numerical or alphabetical Sort by feature density:
695 * based on counts - ignoring individual text or scores for each feature
697 public static String FEATURE_SCORE = "average_score";
699 public static String FEATURE_LABEL = "text";
701 public static String FEATURE_DENSITY = "density";
704 * sort the alignment using the features on each sequence found between start
705 * and stop with the given featureLabel (and optional group qualifier)
707 * @param featureLabel
712 * (-1 to include non-positional features)
714 * (-1 to only sort on non-positional features)
716 * - aligned sequences containing features
718 * - one of the string constants FEATURE_SCORE, FEATURE_LABEL,
721 public static void sortByFeature(String featureLabel, String groupLabel,
722 int start, int stop, AlignmentI alignment, String method)
724 sortByFeature(featureLabel == null ? null : new String[]
725 { featureLabel }, groupLabel == null ? null : new String[]
726 { groupLabel }, start, stop, alignment, method);
729 private static boolean containsIgnoreCase(final String lab,
740 for (int q = 0; q < labs.length; q++)
742 if (labs[q] != null && lab.equalsIgnoreCase(labs[q]))
750 public static void sortByFeature(String[] featureLabels,
751 String[] groupLabels, int start, int stop, AlignmentI alignment,
754 if (method != FEATURE_SCORE && method != FEATURE_LABEL
755 && method != FEATURE_DENSITY)
758 "Implementation Error - sortByFeature method must be one of FEATURE_SCORE, FEATURE_LABEL or FEATURE_DENSITY.");
760 boolean ignoreScore = method != FEATURE_SCORE;
761 StringBuffer scoreLabel = new StringBuffer();
762 scoreLabel.append(start + stop + method);
763 // This doesn't quite work yet - we'd like to have a canonical ordering that
764 // can be preserved from call to call
765 for (int i = 0; featureLabels != null && i < featureLabels.length; i++)
767 scoreLabel.append(featureLabels[i] == null ? "null"
770 for (int i = 0; groupLabels != null && i < groupLabels.length; i++)
772 scoreLabel.append(groupLabels[i] == null ? "null" : groupLabels[i]);
774 SequenceI[] seqs = alignment.getSequencesArray();
776 boolean[] hasScore = new boolean[seqs.length]; // per sequence score
778 int hasScores = 0; // number of scores present on set
779 double[] scores = new double[seqs.length];
780 int[] seqScores = new int[seqs.length];
781 Object[] feats = new Object[seqs.length];
782 double min = 0, max = 0;
783 for (int i = 0; i < seqs.length; i++)
785 SequenceFeature[] sf = seqs[i].getSequenceFeatures();
786 if (sf == null && seqs[i].getDatasetSequence() != null)
788 sf = seqs[i].getDatasetSequence().getSequenceFeatures();
792 sf = new SequenceFeature[0];
796 SequenceFeature[] tmp = new SequenceFeature[sf.length];
797 for (int s = 0; s < tmp.length; s++)
803 int sstart = (start == -1) ? start : seqs[i].findPosition(start);
804 int sstop = (stop == -1) ? stop : seqs[i].findPosition(stop);
808 for (int f = 0; f < sf.length; f++)
810 // filter for selection criteria
812 // ignore features outwith alignment start-stop positions.
813 (sf[f].end < sstart || sf[f].begin > sstop) ||
814 // or ignore based on selection criteria
815 (featureLabels != null && !AlignmentSorter
816 .containsIgnoreCase(sf[f].type, featureLabels))
817 || (groupLabels != null
818 // problem here: we cannot eliminate null feature group features
819 && (sf[f].getFeatureGroup() != null && !AlignmentSorter
820 .containsIgnoreCase(sf[f].getFeatureGroup(),
823 // forget about this feature
829 // or, also take a look at the scores if necessary.
830 if (!ignoreScore && sf[f].getScore() != Float.NaN)
832 if (seqScores[i] == 0)
838 scores[i] += sf[f].getScore(); // take the first instance of this
843 SequenceFeature[] fs;
844 feats[i] = fs = new SequenceFeature[n];
848 for (int f = 0; f < sf.length; f++)
852 ((SequenceFeature[]) feats[i])[n++] = sf[f];
855 if (method == FEATURE_LABEL)
857 // order the labels by alphabet
858 String[] labs = new String[fs.length];
859 for (int l = 0; l < labs.length; l++)
861 labs[l] = (fs[l].getDescription() != null ? fs[l]
862 .getDescription() : fs[l].getType());
864 jalview.util.QuickSort.sort(labs, ((Object[]) feats[i]));
869 // compute average score
870 scores[i] /= seqScores[i];
871 // update the score bounds.
874 max = min = scores[i];
890 if (method == FEATURE_SCORE)
894 return; // do nothing - no scores present to sort by.
897 if (hasScores < seqs.length)
899 for (int i = 0; i < seqs.length; i++)
903 scores[i] = (max + 1 + i);
907 int nf = (feats[i] == null) ? 0
908 : ((SequenceFeature[]) feats[i]).length;
909 // System.err.println("Sorting on Score: seq "+seqs[i].getName()+
910 // " Feats: "+nf+" Score : "+scores[i]);
915 jalview.util.QuickSort.sort(scores, seqs);
917 else if (method == FEATURE_DENSITY)
920 // break ties between equivalent numbers for adjacent sequences by adding
921 // 1/Nseq*i on the original order
922 double fr = 0.9 / (1.0 * seqs.length);
923 for (int i = 0; i < seqs.length; i++)
926 scores[i] = (0.05 + fr * i)
927 + (nf = ((feats[i] == null) ? 0.0
928 : 1.0 * ((SequenceFeature[]) feats[i]).length));
929 // System.err.println("Sorting on Density: seq "+seqs[i].getName()+
930 // " Feats: "+nf+" Score : "+scores[i]);
932 jalview.util.QuickSort.sort(scores, seqs);
936 if (method == FEATURE_LABEL)
938 throw new Error("Not yet implemented.");
941 if (lastSortByFeatureScore == null
942 || !scoreLabel.toString().equals(lastSortByFeatureScore))
944 sortByFeatureScoreAscending = true;
948 sortByFeatureScoreAscending = !sortByFeatureScoreAscending;
950 if (sortByFeatureScoreAscending)
952 setOrder(alignment, seqs);
956 setReverseOrder(alignment, seqs);
958 lastSortByFeatureScore = scoreLabel.toString();