Exemplo n.º 1
0
 def enforce_multisequence_nonmatch_intervals(
     cls, match_intervals: Intervals, non_match_intervals: Intervals, alignment: MSA
 ) -> None:
     """
     Goes through non-match intervals and makes sure there is more than one sequence there, else makes it a match
     interval.
     Modifies the intervals in-place.
     Example reasons for such a conversion to occur:
         - 'N' in a sequence causes it to be filtered out, and left with a single useable sequence
         - '-' in sequences causes them to appear different, but they are the same
     """
     if len(alignment) == 0:  # For testing convenience
         return
     for i in reversed(range(len(non_match_intervals))):
         interval = non_match_intervals[i]
         interval_alignment = alignment[:, interval.start : interval.stop + 1]
         interval_seqs = get_interval_seqs(interval_alignment)
         if len(interval_seqs) < 2:
             changed_interval = non_match_intervals[i]
             match_intervals.append(
                 Interval(
                     IntervalType.Match,
                     changed_interval.start,
                     changed_interval.stop,
                 )
             )
             non_match_intervals.pop(i)
Exemplo n.º 2
0
 def test_first_sequence_in_is_first_sequence_out(self):
     alignment = AlignIO.MultipleSeqAlignment([
         SeqRecord(Seq("TTTT")),
         SeqRecord(Seq("AAAA")),
         SeqRecord(Seq("CC-C")),
     ])
     result = get_interval_seqs(alignment)
     expected = ["TTTT", "AAAA", "CCC"]
     self.assertEqual(expected, result)
Exemplo n.º 3
0
 def check_nonmatch_intervals(self):
     """
     Goes through non-match intervals and makes sure there is more than one sequence there, else makes it a match
     interval.
     Example reasons for such a conversion to occur:
         - 'N' in a sequence causes it to be filtered out, and left with a single useable sequence
         - '-' in sequences causes them to appear different, but they are the same
     """
     for i in reversed(range(len(self.non_match_intervals))):
         interval = self.non_match_intervals[i]
         interval_alignment = self.alignment[:, interval[0]:interval[1] + 1]
         interval_seqs = get_interval_seqs(interval_alignment)
         if len(interval_seqs) < 2:
             self.match_intervals.append(self.non_match_intervals[i])
             self.non_match_intervals.pop(i)
     self.match_intervals.sort()
Exemplo n.º 4
0
    def _get_prg(self):
        prg = ""

        for interval in self.all_intervals:
            if interval in self.match_intervals:
                # all seqs are not necessarily exactly the same: some can have 'N'
                # thus still process all of them, to get the one with no 'N'.
                sub_alignment = self.alignment[:, interval.start : interval.stop + 1]
                seqs = get_interval_seqs(sub_alignment)
                assert len(seqs) == 1, "Got >1 filtered sequences in match interval"
                seq = seqs[0]
                prg += seq

            else:
                # Define variant site number and increment for next available
                site_num = self.site
                self.site += 2
                variant_prgs = []

                # Define the variant seqs to add
                if (self.nesting_level == self.max_nesting) or (
                    interval.stop - interval.start <= self.min_match_length
                ):
                    logging.debug(
                        "Have reached max nesting level or have a small variant site, so add all variant "
                        "sequences in interval."
                    )
                    sub_alignment = self.alignment[
                        :, interval.start : interval.stop + 1
                    ]
                    variant_prgs = get_interval_seqs(sub_alignment)
                    logging.debug(f"Variant seqs found: {variant_prgs}")
                else:
                    recur = True
                    id_lists = kmeans_cluster_seqs_in_interval(
                        [interval.start, interval.stop],
                        self.alignment,
                        self.min_match_length,
                    )
                    list_sub_alignments = [
                        self.get_sub_alignment_by_list_id(
                            id_list, self.alignment, [interval.start, interval.stop]
                        )
                        for id_list in id_lists
                    ]
                    num_clusters = len(id_lists)

                    if len(list_sub_alignments) == self.num_seqs:
                        logging.debug(
                            "Clustering did not group any sequences together, each seq is a cluster"
                        )
                        recur = False
                    elif interval.start not in self.subAlignedSeqs:
                        self.subAlignedSeqs[interval.start] = []
                        logging.debug(
                            "subAlignedSeqs now has keys: %s",
                            list(self.subAlignedSeqs.keys()),
                        )
                    else:
                        logging.debug(
                            "subAlignedSeqs already had key %d in keys: %s. This shouldn't happen.",
                            interval.start,
                            list(self.subAlignedSeqs.keys()),
                        )

                    while len(list_sub_alignments) > 0:
                        sub_alignment = list_sub_alignments.pop(0)
                        sub_aligned_seq = PrgBuilder(
                            msa_file=self.msa_file,
                            alignment_format=self.alignment_format,
                            max_nesting=self.max_nesting,
                            nesting_level=self.nesting_level + 1,
                            min_match_length=self.min_match_length,
                            site=self.site,
                            alignment=sub_alignment,
                            interval=interval,
                        )
                        variant_prgs.append(sub_aligned_seq.prg)
                        self.site = sub_aligned_seq.site

                        if recur:
                            self.subAlignedSeqs[interval.start].append(sub_aligned_seq)
                    assert num_clusters == len(variant_prgs), (
                        "I don't seem to have a sub-prg sequence for all parts of the partition - there are %d "
                        "classes in partition, and %d variant seqs"
                        % (num_clusters, len(variant_prgs))
                    )
                assert len(variant_prgs) > 1, "Only have one variant seq"

                assert len(variant_prgs) == len(
                    list(remove_duplicates(variant_prgs))
                ), "have repeat variant seqs"

                # Add the variant seqs to the prg.
                prg += f"{self.delim_char}{site_num}{self.delim_char}"
                while len(variant_prgs) > 1:
                    prg += variant_prgs.pop(0)
                    prg += f"{self.delim_char}{site_num + 1}{self.delim_char}"
                prg += variant_prgs.pop()
                prg += f"{self.delim_char}{site_num}{self.delim_char}"

        return prg
Exemplo n.º 5
0
 def test_ambiguous_bases_one_seq_with_repeated_base(self):
     alignment = AlignIO.MultipleSeqAlignment([SeqRecord(Seq("RRAAT"))])
     result = get_interval_seqs(alignment)
     expected = {"GAAAT", "AAAAT", "GGAAT", "AGAAT"}
     self.assertEqual(set(result), expected)
Exemplo n.º 6
0
    def get_prg(self):
        prg = ""
        # last_char = None
        # skip_char = False

        for interval in self.all_intervals:
            if interval in self.match_intervals:
                # all seqs are not necessarily exactly the same: some can have 'N'
                # thus still process all of them, to get the one with no 'N'.
                sub_alignment = self.alignment[:, interval[0]:interval[1] + 1]
                seqs = get_interval_seqs(sub_alignment)
                assert 0 < len(
                    seqs) <= 1, "Got >1 filtered sequences in match interval"
                seq = seqs[0]
                prg += seq

            else:
                # Define variant site number and increment for next available
                site_num = self.site
                self.site += 2
                variant_prgs = []

                # Define the variant seqs to add
                if (self.nesting_level == self.max_nesting) or (
                        interval[1] - interval[0] <= self.min_match_length):
                    # Have reached max nesting level, just add all variants in interval.
                    logging.debug(
                        "Have reached max nesting level or have a small variant site, so add all variant "
                        "sequences in interval.")
                    sub_alignment = self.alignment[:,
                                                   interval[0]:interval[1] + 1]
                    logging.debug("Variant seqs found: %s" % list(
                        remove_duplicates(
                            [str(record.seq) for record in sub_alignment])))
                    variant_prgs = get_interval_seqs(sub_alignment)
                    logging.debug("Which is equivalent to: %s" % variant_prgs)
                else:
                    # divide sequences into subgroups and define prg for each subgroup.
                    logging.debug(
                        "Divide sequences into subgroups and define prg for each subgroup."
                    )
                    recur = True
                    id_lists = self.kmeans_cluster_seqs_in_interval(
                        interval, self.alignment, self.min_match_length)
                    list_sub_alignments = [
                        self.get_sub_alignment_by_list_id(
                            id_list, self.alignment, interval)
                        for id_list in id_lists
                    ]
                    num_clusters = len(id_lists)

                    if len(list_sub_alignments) == self.num_seqs:
                        logging.debug(
                            "Clustering did not group any sequences together, each seq is a cluster"
                        )
                        recur = False
                    elif interval[0] not in self.subAlignedSeqs:
                        self.subAlignedSeqs[interval[0]] = []
                        logging.debug(
                            "subAlignedSeqs now has keys: %s",
                            list(self.subAlignedSeqs.keys()),
                        )
                    else:
                        logging.debug(
                            "subAlignedSeqs already had key %d in keys: %s. This shouldn't happen.",
                            interval[0],
                            list(self.subAlignedSeqs.keys()),
                        )

                    while len(list_sub_alignments) > 0:
                        sub_alignment = list_sub_alignments.pop(0)
                        sub_aligned_seq = AlignedSeq(
                            msa_file=self.msa_file,
                            alignment_format=self.alignment_format,
                            max_nesting=self.max_nesting,
                            nesting_level=self.nesting_level + 1,
                            min_match_length=self.min_match_length,
                            site=self.site,
                            alignment=sub_alignment,
                            interval=interval,
                        )
                        variant_prgs.append(sub_aligned_seq.prg)
                        self.site = sub_aligned_seq.site

                        if recur:
                            # logging.debug("None not in snp_scores - try to add sub__aligned_seq to list in
                            # dictionary")
                            self.subAlignedSeqs[interval[0]].append(
                                sub_aligned_seq)
                            # logging.debug("Length of subAlignedSeqs[%d] is %d", interval[0],
                            # len(self.subAlignedSeqs[interval[0]]))
                    assert num_clusters == len(variant_prgs), (
                        "I don't seem to have a sub-prg sequence for all parts of the partition - there are %d "
                        "classes in partition, and %d variant seqs" %
                        (num_clusters, len(variant_prgs)))
                assert len(variant_prgs) > 1, "Only have one variant seq"

                assert len(variant_prgs) == len(
                    list(remove_duplicates(
                        variant_prgs))), "have repeat variant seqs"

                # Add the variant seqs to the prg
                prg += "%s%d%s" % (
                    self.delim_char,
                    site_num,
                    self.delim_char,
                )  # considered making it so start of prg was not delim_char,
                # but that would defeat the point if it
                while len(variant_prgs) > 1:
                    prg += variant_prgs.pop(0)
                    prg += "%s%d%s" % (self.delim_char, site_num + 1,
                                       self.delim_char)
                prg += variant_prgs.pop()
                prg += "%s%d%s" % (self.delim_char, site_num, self.delim_char)

        return prg
Exemplo n.º 7
0
    def kmeans_cluster_seqs_in_interval(
        self,
        interval: List[int],
        alignment: MultipleSeqAlignment,
        min_match_length: int,
    ) -> List[List[str]]:
        """Divide sequences in interval into subgroups of similar sequences."""
        interval_alignment = alignment[:, interval[0]:interval[1] + 1]

        if interval[1] - interval[0] <= min_match_length:
            logging.info("Small variation site in interval %s \n", interval)
            interval_seqs = get_interval_seqs(interval_alignment)
            id_lists = [[
                record.id for record in alignment
                if record.seq[interval[0]:interval[1] + 1].ungap("-") == seq
            ] for seq in interval_seqs]
            return id_lists

        logging.debug("Get kmeans partition of interval [%d, %d]", interval[0],
                      interval[1])

        seq_to_ids = defaultdict(list)
        small_seq_to_ids = defaultdict(list)

        for record in interval_alignment:
            seq = str(record.seq.ungap("-"))
            if len(seq) >= min_match_length:
                seq_to_ids[seq].append(record.id)
            else:
                small_seq_to_ids[seq].append(record.id)
        logging.debug(f"Add classes for {len(seq_to_ids)} long "
                      f"and {len(small_seq_to_ids)} small sequences")

        # The clustering is performed on unique sequences
        clustered_ids = []
        if len(seq_to_ids) <= 1:
            logging.info(
                "<= 1 sequence >= min_match_len, no clustering to perform.")
            if len(seq_to_ids) == 1:
                clustered_ids = [list(seq_to_ids.values())[0]]

        else:
            # first transform sequences into kmer occurrence vectors using a dict
            logging.debug(
                "First transform sequences into kmer occurrence vectors")

            # collect all kmers
            kmer_dict = {}
            n = 0
            for seq in seq_to_ids:
                for i in range(len(seq) - min_match_length + 1):
                    kmer = seq[i:i + min_match_length]
                    if kmer not in kmer_dict:
                        kmer_dict[kmer] = n
                        n += 1
            logging.debug(f"Found {n} kmers")

            # count all kmers
            seq_kmer_counts = np.zeros(shape=(len(seq_to_ids), n))
            for j, seq in enumerate(seq_to_ids):
                counts = np.zeros(n)
                for i in range(len(seq) - min_match_length + 1):
                    kmer = seq[i:i + min_match_length]
                    counts[kmer_dict[kmer]] += 1
                seq_kmer_counts[j] = counts

            # cluster sequences using kmeans
            logging.debug("Now cluster:")
            kmeans = KMeans(n_clusters=1, random_state=2).fit(seq_kmer_counts)
            pre_cluster_inertia = kmeans.inertia_

            cluster_inertia = pre_cluster_inertia
            number_of_clusters = 1
            logging.debug(f"initial inertia: {cluster_inertia}")
            while (cluster_inertia > 0
                   and cluster_inertia > pre_cluster_inertia / 2
                   and number_of_clusters < len(seq_to_ids)):
                number_of_clusters += 1
                kmeans = KMeans(n_clusters=number_of_clusters,
                                random_state=2).fit(seq_kmer_counts)
                cluster_inertia = kmeans.inertia_
                logging.debug(
                    "number of clusters: %d, inertia: %f",
                    number_of_clusters,
                    cluster_inertia,
                )

            # convert cluster numbers to sequence record IDs
            logging.debug("Extract equivalence classes from this partition")
            if pre_cluster_inertia > 0:
                cluster_ids = list(kmeans.predict(seq_kmer_counts))
                for i in range(max(cluster_ids) + 1):
                    clustered_ids.append([])
                all_ids = list(seq_to_ids.values())
                for i, cluster_id in enumerate(cluster_ids):
                    clustered_ids[cluster_id].extend(all_ids[i])
            else:
                logging.debug("pre_cluster_inertia is 0! No clustering.")
                clustered_ids = list(seq_to_ids.values())

        logging.debug("Merge id lists for the partitions")
        first_id = interval_alignment[0].id
        id_lists = [[]]  # Reserve space for first seq id
        for cluster in clustered_ids:
            if first_id in set(cluster):
                id_lists[0] = cluster
            else:
                id_lists.append(cluster)

        for ids in small_seq_to_ids.values():
            if first_id in set(ids):
                id_lists[0] = ids
            else:
                id_lists.append(ids)

        assert len(interval_alignment) == sum(
            [len(i) for i in id_lists]
        ), "I seem to have lost (or gained?) some sequences in the process of clustering"
        return id_lists