jpayne@17: #!/usr/bin/env python3 jpayne@17: jpayne@17: import sys jpayne@17: import time jpayne@17: import random jpayne@17: import os jpayne@17: import subprocess jpayne@17: import gzip jpayne@17: import io jpayne@17: import pickle jpayne@17: import argparse jpayne@17: import itertools jpayne@17: from distutils.version import LooseVersion jpayne@17: from distutils.spawn import find_executable jpayne@17: sys.path.insert(1,sys.path[0]+'/..') jpayne@17: jpayne@17: try: jpayne@17: from .version import SeqSero2_version jpayne@17: except Exception: #ImportError jpayne@17: from version import SeqSero2_version jpayne@17: jpayne@17: ### SeqSero Kmer jpayne@17: def parse_args(): jpayne@17: "Parse the input arguments, use '-h' for help." jpayne@17: parser = argparse.ArgumentParser(usage='SeqSero2_package.py -t -m -i [-d ] [-p ] [-b ]\n\nDevelopper: Shaokang Zhang (zskzsk@uga.edu), Hendrik C Den-Bakker (Hendrik.DenBakker@uga.edu) and Xiangyu Deng (xdeng@uga.edu)\n\nContact email:seqsero@gmail.com\n\nVersion: v1.3.1')#add "-m " in future jpayne@17: parser.add_argument("-i",nargs="+",help=": path/to/input_data",type=os.path.abspath) ### add 'type=os.path.abspath' to generate absolute path of input data. jpayne@17: parser.add_argument("-t",choices=['1','2','3','4','5'],help=": '1' for interleaved paired-end reads, '2' for separated paired-end reads, '3' for single reads, '4' for genome assembly, '5' for nanopore reads (fasta/fastq)") jpayne@17: parser.add_argument("-b",choices=['sam','mem'],default="mem",help=": algorithms for bwa mapping for allele mode; 'mem' for mem, 'sam' for samse/sampe; default=mem; optional; for now we only optimized for default 'mem' mode") jpayne@17: parser.add_argument("-p",default="1",help=": number of threads for allele mode, if p >4, only 4 threads will be used for assembly since the amount of extracted reads is small, default=1") jpayne@17: parser.add_argument("-m",choices=['k','a'],default="a",help=": which workflow to apply, 'a'(raw reads allele micro-assembly), 'k'(raw reads and genome assembly k-mer), default=a") jpayne@17: parser.add_argument("-n",help=": optional, to specify a sample name in the report output") jpayne@17: parser.add_argument("-d",help=": optional, to specify an output directory name, if not set, the output directory would be 'SeqSero_result_'+time stamp+one random number") jpayne@17: parser.add_argument("-c",action="store_true",help=": if '-c' was flagged, SeqSero2 will only output serotype prediction without the directory containing log files") jpayne@17: parser.add_argument("-s",action="store_true",help=": if '-s' was flagged, SeqSero2 will not output header in SeqSero_result.tsv") jpayne@17: parser.add_argument("--phred_offset",choices=['33','64','auto'],default='auto',help="<33|64|auto>: offset for FASTQ file quality scores, default=auto") jpayne@17: parser.add_argument("--check",action="store_true",help=": use '--check' flag to check the required dependencies") jpayne@17: parser.add_argument('-v', '--version', action='version', version='%(prog)s ' + SeqSero2_version) jpayne@17: return parser.parse_args() jpayne@17: jpayne@17: ### check paths of dependencies jpayne@17: check_dependencies = parse_args().check jpayne@17: dependencies = ['bwa','samtools','blastn','fastq-dump','spades.py','bedtools','SalmID.py'] jpayne@17: if check_dependencies: jpayne@17: for item in dependencies: jpayne@17: ext_path = find_executable(item) jpayne@17: if ext_path is not None: jpayne@17: print ("Using "+item+" - "+ext_path) jpayne@17: else: jpayne@17: print ("ERROR: can not find "+item+" in PATH") jpayne@17: sys.exit() jpayne@17: ### end of --check jpayne@17: jpayne@17: def reverse_complement(sequence): jpayne@17: complement = { jpayne@17: 'A': 'T', jpayne@17: 'C': 'G', jpayne@17: 'G': 'C', jpayne@17: 'T': 'A', jpayne@17: 'N': 'N', jpayne@17: 'M': 'K', jpayne@17: 'R': 'Y', jpayne@17: 'W': 'W', jpayne@17: 'S': 'S', jpayne@17: 'Y': 'R', jpayne@17: 'K': 'M', jpayne@17: 'V': 'B', jpayne@17: 'H': 'D', jpayne@17: 'D': 'H', jpayne@17: 'B': 'V' jpayne@17: } jpayne@17: return "".join(complement[base] for base in reversed(sequence)) jpayne@17: jpayne@17: jpayne@17: def createKmerDict_reads(list_of_strings, kmer): jpayne@17: kmer_table = {} jpayne@17: for string in list_of_strings: jpayne@17: sequence = string.strip('\n') jpayne@17: for i in range(len(sequence) - kmer + 1): jpayne@17: new_mer = sequence[i:i + kmer].upper() jpayne@17: new_mer_rc = reverse_complement(new_mer) jpayne@17: if new_mer in kmer_table: jpayne@17: kmer_table[new_mer.upper()] += 1 jpayne@17: else: jpayne@17: kmer_table[new_mer.upper()] = 1 jpayne@17: if new_mer_rc in kmer_table: jpayne@17: kmer_table[new_mer_rc.upper()] += 1 jpayne@17: else: jpayne@17: kmer_table[new_mer_rc.upper()] = 1 jpayne@17: return kmer_table jpayne@17: jpayne@17: jpayne@17: def multifasta_dict(multifasta): jpayne@17: multifasta_list = [ jpayne@17: line.strip() for line in open(multifasta, 'r') if len(line.strip()) > 0 jpayne@17: ] jpayne@17: headers = [i for i in multifasta_list if i[0] == '>'] jpayne@17: multifasta_dict = {} jpayne@17: for h in headers: jpayne@17: start = multifasta_list.index(h) jpayne@17: for element in multifasta_list[start + 1:]: jpayne@17: if element[0] == '>': jpayne@17: break jpayne@17: else: jpayne@17: if h[1:] in multifasta_dict: jpayne@17: multifasta_dict[h[1:]] += element jpayne@17: else: jpayne@17: multifasta_dict[h[1:]] = element jpayne@17: return multifasta_dict jpayne@17: jpayne@17: jpayne@17: def multifasta_single_string(multifasta): jpayne@17: multifasta_list = [ jpayne@17: line.strip() for line in open(multifasta, 'r') jpayne@17: if (len(line.strip()) > 0) and (line.strip()[0] != '>') jpayne@17: ] jpayne@17: return ''.join(multifasta_list) jpayne@17: jpayne@17: jpayne@17: def chunk_a_long_sequence(long_sequence, chunk_size=60): jpayne@17: chunk_list = [] jpayne@17: steps = len(long_sequence) // 60 #how many chunks jpayne@17: for i in range(steps): jpayne@17: chunk_list.append(long_sequence[i * chunk_size:(i + 1) * chunk_size]) jpayne@17: chunk_list.append(long_sequence[steps * chunk_size:len(long_sequence)]) jpayne@17: return chunk_list jpayne@17: jpayne@17: jpayne@17: def target_multifasta_kmerizer(multifasta, k, kmerDict): jpayne@17: forward_length = 300 #if find the target, put forward 300 bases jpayne@17: reverse_length = 2200 #if find the target, put backward 2200 bases jpayne@17: chunk_size = 60 #it will firstly chunk the single long sequence to multiple smaller sequences, it controls the size of those smaller sequences jpayne@17: target_mers = [] jpayne@17: long_single_string = multifasta_single_string(multifasta) jpayne@17: multifasta_list = chunk_a_long_sequence(long_single_string, chunk_size) jpayne@17: unit_length = len(multifasta_list[0]) jpayne@17: forward_lines = int(forward_length / unit_length) + 1 jpayne@17: reverse_lines = int(forward_length / unit_length) + 1 jpayne@17: start_num = 0 jpayne@17: end_num = 0 jpayne@17: for i in range(len(multifasta_list)): jpayne@17: if i not in range(start_num, end_num): #avoid computational repetition jpayne@17: line = multifasta_list[i] jpayne@17: start = int((len(line) - k) // 2) jpayne@17: s1 = line[start:k + start] jpayne@17: if s1 in kmerDict: #detect it is a potential read or not (use the middle part) jpayne@17: if i - forward_lines >= 0: jpayne@17: start_num = i - forward_lines jpayne@17: else: jpayne@17: start_num = 0 jpayne@17: if i + reverse_lines <= len(multifasta_list) - 1: jpayne@17: end_num = i + reverse_lines jpayne@17: else: jpayne@17: end_num = len(multifasta_list) - 1 jpayne@17: target_list = [ jpayne@17: x.strip() for x in multifasta_list[start_num:end_num] jpayne@17: ] jpayne@17: target_line = "".join(target_list) jpayne@17: target_mers += [ jpayne@17: k1 for k1 in createKmerDict_reads([str(target_line)], k) jpayne@17: ] ##changed k to k1, just want to avoid the mixes of this "k" (kmer) to the "k" above (kmer length) jpayne@17: else: jpayne@17: pass jpayne@17: return set(target_mers) jpayne@17: jpayne@17: jpayne@17: def target_read_kmerizer(file, k, kmerDict): jpayne@17: i = 1 jpayne@17: n_reads = 0 jpayne@17: total_coverage = 0 jpayne@17: target_mers = [] jpayne@17: if file.endswith(".gz"): jpayne@17: file_content = io.BufferedReader(gzip.open(file)) jpayne@17: else: jpayne@17: file_content = open(file, "r").readlines() jpayne@17: for line in file_content: jpayne@17: start = int((len(line) - k) // 2) jpayne@17: if i % 4 == 2: jpayne@17: if file.endswith(".gz"): jpayne@17: s1 = line[start:k + start].decode() jpayne@17: line = line.decode() jpayne@17: else: jpayne@17: s1 = line[start:k + start] jpayne@17: if s1 in kmerDict: #detect it is a potential read or not (use the middle part) jpayne@17: n_reads += 1 jpayne@17: total_coverage += len(line) jpayne@17: target_mers += [ jpayne@17: k1 for k1 in createKmerDict_reads([str(line)], k) jpayne@17: ] #changed k to k1, just want to avoid the mixes of this "k" (kmer) to the "k" above (kmer length) jpayne@17: i += 1 jpayne@17: if total_coverage >= 4000000: jpayne@17: break jpayne@17: return set(target_mers) jpayne@17: jpayne@17: jpayne@17: def minion_fasta_kmerizer(file, k, kmerDict): jpayne@17: i = 1 jpayne@17: n_reads = 0 jpayne@17: total_coverage = 0 jpayne@17: target_mers = {} jpayne@17: for line in open(file): jpayne@17: if i % 2 == 0: jpayne@17: for kmer, rc_kmer in kmers(line.strip().upper(), k): jpayne@17: if (kmer in kmerDict) or (rc_kmer in kmerDict): jpayne@17: if kmer in target_mers: jpayne@17: target_mers[kmer] += 1 jpayne@17: else: jpayne@17: target_mers[kmer] = 1 jpayne@17: if rc_kmer in target_mers: jpayne@17: target_mers[rc_kmer] += 1 jpayne@17: else: jpayne@17: target_mers[rc_kmer] = 1 jpayne@17: i += 1 jpayne@17: return set([h for h in target_mers]) jpayne@17: jpayne@17: jpayne@17: def minion_fastq_kmerizer(file, k, kmerDict): jpayne@17: i = 1 jpayne@17: n_reads = 0 jpayne@17: total_coverage = 0 jpayne@17: target_mers = {} jpayne@17: for line in open(file): jpayne@17: if i % 4 == 2: jpayne@17: for kmer, rc_kmer in kmers(line.strip().upper(), k): jpayne@17: if (kmer in kmerDict) or (rc_kmer in kmerDict): jpayne@17: if kmer in target_mers: jpayne@17: target_mers[kmer] += 1 jpayne@17: else: jpayne@17: target_mers[kmer] = 1 jpayne@17: if rc_kmer in target_mers: jpayne@17: target_mers[rc_kmer] += 1 jpayne@17: else: jpayne@17: target_mers[rc_kmer] = 1 jpayne@17: i += 1 jpayne@17: return set([h for h in target_mers]) jpayne@17: jpayne@17: jpayne@17: def multifasta_single_string2(multifasta): jpayne@17: single_string = '' jpayne@17: with open(multifasta, 'r') as f: jpayne@17: for line in f: jpayne@17: if line.strip()[0] == '>': jpayne@17: pass jpayne@17: else: jpayne@17: single_string += line.strip() jpayne@17: return single_string jpayne@17: jpayne@17: jpayne@17: def kmers(seq, k): jpayne@17: rev_comp = reverse_complement(seq) jpayne@17: for start in range(1, len(seq) - k + 1): jpayne@17: yield seq[start:start + k], rev_comp[-(start + k):-start] jpayne@17: jpayne@17: jpayne@17: def multifasta_to_kmers_dict(multifasta,k_size):#used to create database kmer set jpayne@17: multi_seq_dict = multifasta_dict(multifasta) jpayne@17: lib_dict = {} jpayne@17: for h in multi_seq_dict: jpayne@17: lib_dict[h] = set( jpayne@17: [k for k in createKmerDict_reads([multi_seq_dict[h]], k_size)]) jpayne@17: return lib_dict jpayne@17: jpayne@17: jpayne@17: def Combine(b, c): jpayne@17: fliC_combinations = [] jpayne@17: fliC_combinations.append(",".join(c)) jpayne@17: temp_combinations = [] jpayne@17: for i in range(len(b)): jpayne@17: for x in itertools.combinations(b, i + 1): jpayne@17: temp_combinations.append(",".join(x)) jpayne@17: for x in temp_combinations: jpayne@17: temp = [] jpayne@17: for y in c: jpayne@17: temp.append(y) jpayne@17: temp.append(x) jpayne@17: temp = ",".join(temp) jpayne@17: temp = temp.split(",") jpayne@17: temp.sort() jpayne@17: temp = ",".join(temp) jpayne@17: fliC_combinations.append(temp) jpayne@17: return fliC_combinations jpayne@17: jpayne@17: jpayne@17: def seqsero_from_formula_to_serotypes(Otype, fliC, fljB, special_gene_list,subspecies): jpayne@17: #like test_output_06012017.txt jpayne@17: #can add more varialbles like sdf-type, sub-species-type in future (we can conclude it into a special-gene-list) jpayne@17: from Initial_Conditions import phase1,phase2,phaseO,sero,subs,remove_list,rename_dict jpayne@17: rename_dict_not_anymore=[rename_dict[x] for x in rename_dict] jpayne@17: rename_dict_all=rename_dict_not_anymore+list(rename_dict) #used for decide whether to jpayne@17: seronames = [] jpayne@17: seronames_none_subspecies=[] jpayne@17: for i in range(len(phase1)): jpayne@17: fliC_combine = [] jpayne@17: fljB_combine = [] jpayne@17: if phaseO[i] == Otype: # no VII in KW, but it's there jpayne@17: ### for fliC, detect every possible combinations to avoid the effect of "[" jpayne@17: if phase1[i].count("[") == 0: jpayne@17: fliC_combine.append(phase1[i]) jpayne@17: elif phase1[i].count("[") >= 1: jpayne@17: c = [] jpayne@17: b = [] jpayne@17: if phase1[i][0] == "[" and phase1[i][-1] == "]" and phase1[i].count( jpayne@17: "[") == 1: jpayne@17: content = phase1[i].replace("[", "").replace("]", "") jpayne@17: fliC_combine.append(content) jpayne@17: fliC_combine.append("-") jpayne@17: else: jpayne@17: for x in phase1[i].split(","): jpayne@17: if "[" in x: jpayne@17: b.append(x.replace("[", "").replace("]", "")) jpayne@17: else: jpayne@17: c.append(x) jpayne@17: fliC_combine = Combine( jpayne@17: b, c jpayne@17: ) #Combine will offer every possible combinations of the formula, like f,[g],t: f,t f,g,t jpayne@17: ### end of fliC "[" detect jpayne@17: ### for fljB, detect every possible combinations to avoid the effect of "[" jpayne@17: if phase2[i].count("[") == 0: jpayne@17: fljB_combine.append(phase2[i]) jpayne@17: elif phase2[i].count("[") >= 1: jpayne@17: d = [] jpayne@17: e = [] jpayne@17: if phase2[i][0] == "[" and phase2[i][-1] == "]" and phase2[i].count( jpayne@17: "[") == 1: jpayne@17: content = phase2[i].replace("[", "").replace("]", "") jpayne@17: fljB_combine.append(content) jpayne@17: fljB_combine.append("-") jpayne@17: else: jpayne@17: for x in phase2[i].split(","): jpayne@17: if "[" in x: jpayne@17: d.append(x.replace("[", "").replace("]", "")) jpayne@17: else: jpayne@17: e.append(x) jpayne@17: fljB_combine = Combine(d, e) jpayne@17: ### end of fljB "[" detect jpayne@17: new_fliC = fliC.split( jpayne@17: "," jpayne@17: ) #because some antigen like r,[i] not follow alphabetical order, so use this one to judge and can avoid missings jpayne@17: new_fliC.sort() jpayne@17: new_fliC = ",".join(new_fliC) jpayne@17: new_fljB = fljB.split(",") jpayne@17: new_fljB.sort() jpayne@17: new_fljB = ",".join(new_fljB) jpayne@17: if (new_fliC in fliC_combine jpayne@17: or fliC in fliC_combine) and (new_fljB in fljB_combine jpayne@17: or fljB in fljB_combine): jpayne@17: ######start, remove_list,rename_dict, added on 11/11/2018 jpayne@17: if sero[i] not in remove_list: jpayne@17: temp_sero=sero[i] jpayne@17: if temp_sero in rename_dict: jpayne@17: temp_sero=rename_dict[temp_sero] #rename if in the rename list jpayne@17: if temp_sero not in seronames:#the new sero may already included, if yes, then not consider jpayne@17: if subs[i] == subspecies: jpayne@17: seronames.append(temp_sero) jpayne@17: seronames_none_subspecies.append(temp_sero) jpayne@17: else: jpayne@17: pass jpayne@17: else: jpayne@17: pass jpayne@17: ######end, added on 11/11/2018 jpayne@17: #analyze seronames jpayne@17: subspecies_pointer="" jpayne@17: if len(seronames) == 0 and len(seronames_none_subspecies)!=0: jpayne@17: ## ed_SL_06062020: for the subspecies mismatch between KW and SalmID jpayne@17: seronames=seronames_none_subspecies jpayne@17: #seronames=["N/A"] jpayne@17: subspecies_pointer="1" jpayne@17: #subspecies_pointer="0" jpayne@17: ## jpayne@17: if len(seronames) == 0: jpayne@17: seronames = [ jpayne@17: "N/A (The predicted antigenic profile does not exist in the White-Kauffmann-Le Minor scheme)" jpayne@17: ] jpayne@17: star = "" jpayne@17: star_line = "" jpayne@17: if len(seronames) > 1: #there are two possible predictions for serotypes jpayne@17: star = "*" jpayne@17: #changed 04072019 jpayne@17: #star_line = "The predicted serotypes share the same general formula:\t" + Otype + ":" + fliC + ":" + fljB + "\n" jpayne@17: if subspecies_pointer=="1" and len(seronames_none_subspecies)!=0: jpayne@17: star="*" jpayne@17: star_line = "This antigenic profile has been associated with serotype '"+(" or ").join(seronames)+"' in the Kauffman-White scheme. The existence of the same antigenic formula in multiple species or subspecies is well documented in the Kauffman-White Scheme. " + star_line ## ed_SL_03202021: changed for new output format jpayne@17: #star_line="The predicted O and H antigens correspond to serotype '"+(" or ").join(seronames)+"' in the Kauffmann-White scheme. The predicted subspecies by SalmID (github.com/hcdenbakker/SalmID) may not be consistent with subspecies designation in the Kauffmann-White scheme. " + star_line jpayne@17: #star_line="The formula with this subspieces prediction can't get a serotype in KW manual, and the serotyping prediction was made without considering it."+star_line jpayne@17: seronames=["N/A"] ## ed_SL_06062020 jpayne@17: if Otype=="": jpayne@17: Otype="-" jpayne@17: predict_form = Otype + ":" + fliC + ":" + fljB jpayne@17: predict_sero = (" or ").join(seronames) jpayne@17: ###special test for Enteritidis jpayne@17: if predict_form == "9:g,m:-": jpayne@17: sdf = "-" jpayne@17: for x in special_gene_list: jpayne@17: if x.startswith("sdf"): jpayne@17: sdf = "+" jpayne@17: #star_line="Detected sdf gene, a marker to differentiate Gallinarum and Enteritidis" jpayne@17: #star_line="sdf gene detected. " jpayne@17: star_line = "Detected Sdf I that is characteristic of commonly circulating strains of serotype Enteritidis. " jpayne@17: #predict_form = predict_form + " Sdf prediction:" + sdf jpayne@17: predict_form = predict_form #changed 04072019 jpayne@17: if sdf == "-": jpayne@17: star = "*" jpayne@17: #star_line="Didn't detected sdf gene, a marker to differentiate Gallinarum and Enteritidis" jpayne@17: #star_line="sdf gene not detected. " jpayne@17: star_line = "Sdf I that is characteristic of commonly circulating strains of serotype Enteritidis was not detected. " jpayne@17: #changed in 04072019, for new output jpayne@17: #star_line = "Additional characterization is necessary to assign a serotype to this strain. Commonly circulating strains of serotype Enteritidis are sdf+, although sdf- strains of serotype Enteritidis are known to exist. Serotype Gallinarum is typically sdf- but should be quite rare. Sdf- strains of serotype Enteritidis and serotype Gallinarum can be differentiated by phenotypic profile or genetic criteria.\n" jpayne@17: #predict_sero = "Gallinarum/Enteritidis" #04132019, for new output requirement jpayne@17: predict_sero = "Gallinarum or Enteritidis" jpayne@17: ###end of special test for Enteritidis jpayne@17: elif predict_form == "4:i:-": jpayne@17: predict_sero = "I 4,[5],12:i:-" # change serotype name jpayne@17: elif predict_form == "4:r:-": jpayne@17: predict_sero = "N/A (4:r:-)" jpayne@17: elif predict_form == "4:b:-": jpayne@17: predict_sero = "N/A (4:b:-)" jpayne@17: #elif predict_form == "8:e,h:1,2": #removed after official merge of newport and bardo jpayne@17: #predict_sero = "Newport" jpayne@17: #star = "*" jpayne@17: #star_line = "Serotype Bardo shares the same antigenic profile with Newport, but Bardo is exceedingly rare." jpayne@17: claim = "The serotype(s) is/are the only serotype(s) with the indicated antigenic profile currently recognized in the Kauffmann White Scheme. New serotypes can emerge and the possibility exists that this antigenic profile may emerge in a different subspecies. Identification of strains to the subspecies level should accompany serotype determination; the same antigenic profile in different subspecies is considered different serotypes.\n" jpayne@17: if "N/A" in predict_sero: jpayne@17: claim = "" jpayne@17: #special test for Typhimurium jpayne@17: if "Typhimurium" in predict_sero or predict_form == "4:i:-": jpayne@17: normal = 0 jpayne@17: mutation = 0 jpayne@17: for x in special_gene_list: jpayne@17: if "oafA-O-4_full" in x: jpayne@17: normal = float(special_gene_list[x]) jpayne@17: elif "oafA-O-4_5-" in x: jpayne@17: mutation = float(special_gene_list[x]) jpayne@17: if normal > mutation: jpayne@17: pass jpayne@17: elif normal < mutation: jpayne@17: #predict_sero = predict_sero.strip() + "(O5-)" jpayne@17: predict_sero = predict_sero.strip() #diable special sero for new output requirement, 04132019 jpayne@17: star = "*" jpayne@17: #star_line = "Detected the deletion of O5-." jpayne@17: star_line = "Detected a deletion in gene oafA that causes O5- variant of Typhimurium. " jpayne@17: else: jpayne@17: pass jpayne@17: #special test for Paratyphi B jpayne@17: if "Paratyphi B" in predict_sero or predict_form == "4:b:-": jpayne@17: normal = 0 jpayne@17: mutation = 0 jpayne@17: for x in special_gene_list: jpayne@17: if "gntR-family-regulatory-protein_dt-positive" in x: jpayne@17: normal = float(special_gene_list[x]) jpayne@17: elif "gntR-family-regulatory-protein_dt-negative" in x: jpayne@17: mutation = float(special_gene_list[x]) jpayne@17: #print(normal,mutation) jpayne@17: if normal > mutation: jpayne@17: #predict_sero = predict_sero.strip() + "(dt+)" #diable special sero for new output requirement, 04132019 jpayne@17: predict_sero = predict_sero.strip()+' var. L(+) tartrate+' if "Paratyphi B" in predict_sero else predict_sero.strip() jpayne@17: star = "*" jpayne@17: #star_line = "Didn't detect the SNP for dt- which means this isolate is a Paratyphi B variant L(+) tartrate(+)." jpayne@17: star_line = "The SNP in gene STM3356 that is associated with the d-Tartrate nonfermenting phenotype characteristic of the typhoidal pathotype was not detected. " jpayne@17: elif normal < mutation: jpayne@17: #predict_sero = predict_sero.strip() + "(dt-)" #diable special sero for new output requirement, 04132019 jpayne@17: predict_sero = predict_sero.strip() jpayne@17: star = "*" jpayne@17: #star_line = "Detected the SNP for d-Tartrate nonfermenting phenotype of Paratyphi B. " jpayne@17: star_line = "Detected the SNP in gene STM3356 that is associated with the d-Tartrate nonfermenting phenotype characteristic of the typhoidal pathotype. " jpayne@17: else: jpayne@17: star = "*" jpayne@17: #star_line = " Failed to detect the SNP for dt-, can't decide it's a Paratyphi B variant L(+) tartrate(+) or not." jpayne@17: star_line = " " ## ed_SL_05152019: do not report this situation. jpayne@17: #special test for O13,22 and O13,23 jpayne@17: if Otype=="13": jpayne@17: #ex_dir = os.path.dirname(os.path.realpath(__file__)) jpayne@17: ex_dir = os.path.abspath(os.path.join(os.path.dirname(os.path.dirname(__file__)),'seqsero2_db')) # ed_SL_09152019 jpayne@17: f = open(ex_dir + '/special.pickle', 'rb') jpayne@17: special = pickle.load(f) jpayne@17: O22_O23=special['O22_O23'] jpayne@17: if predict_sero.split(" or ")[0] in O22_O23[-1] and predict_sero.split(" or ")[0] not in rename_dict_all:#if in rename_dict_all, then it means already merged, no need to analyze jpayne@17: O22_score=0 jpayne@17: O23_score=0 jpayne@17: for x in special_gene_list: jpayne@17: if "O:22" in x: jpayne@17: O22_score = O22_score+float(special_gene_list[x]) jpayne@17: elif "O:23" in x: jpayne@17: O23_score = O23_score+float(special_gene_list[x]) jpayne@17: #print(O22_score,O23_score) jpayne@17: for z in O22_O23[0]: jpayne@17: if predict_sero.split(" or ")[0] in z: jpayne@17: if O22_score > O23_score: jpayne@17: star = "*" jpayne@17: #star_line = "Detected O22 specific genes to further differenciate '"+predict_sero+"'." #diabled for new output requirement, 04132019 jpayne@17: predict_sero = z[0] jpayne@17: elif O22_score < O23_score: jpayne@17: star = "*" jpayne@17: #star_line = "Detected O23 specific genes to further differenciate '"+predict_sero+"'." #diabled for new output requirement, 04132019 jpayne@17: predict_sero = z[1] jpayne@17: else: jpayne@17: star = "*" jpayne@17: #star_line = "Fail to detect O22 and O23 differences." #diabled for new output requirement, 04132019 jpayne@17: if " or " in predict_sero: jpayne@17: star_line = star_line + "The predicted serotypes share the same general formula: " + Otype + ":" + fliC + ":" + fljB + " and can be differentiated by additional analysis. " jpayne@17: #special test for O6,8 jpayne@17: #merge_O68_list=["Blockley","Bovismorbificans","Hadar","Litchfield","Manhattan","Muenchen"] #remove 11/11/2018, because already in merge list jpayne@17: #for x in merge_O68_list: jpayne@17: # if x in predict_sero: jpayne@17: # predict_sero=x jpayne@17: # star="" jpayne@17: # star_line="" jpayne@17: #special test for Montevideo; most of them are monophasic jpayne@17: #if "Montevideo" in predict_sero and "1,2,7" in predict_form: #remove 11/11/2018, because already in merge list jpayne@17: #star="*" jpayne@17: #star_line="Montevideo is almost always monophasic, having an antigen called for the fljB position may be a result of Salmonella-Salmonella contamination." jpayne@17: return predict_form, predict_sero, star, star_line, claim jpayne@17: ### End of SeqSero Kmer part jpayne@17: jpayne@17: ### Begin of SeqSero2 allele prediction and output jpayne@17: def xml_parse_score_comparision_seqsero(xmlfile): jpayne@17: #used to do seqsero xml analysis jpayne@17: from Bio.Blast import NCBIXML jpayne@17: handle=open(xmlfile) jpayne@17: handle=NCBIXML.parse(handle) jpayne@17: handle=list(handle) jpayne@17: List=[] jpayne@17: List_score=[] jpayne@17: List_ids=[] jpayne@17: List_query_region=[] jpayne@17: for i in range(len(handle)): jpayne@17: if len(handle[i].alignments)>0: jpayne@17: for j in range(len(handle[i].alignments)): jpayne@17: score=0 jpayne@17: ids=0 jpayne@17: cover_region=set() #fixed problem that repeated calculation leading percentage > 1 jpayne@17: List.append(handle[i].query.strip()+"___"+handle[i].alignments[j].hit_def) jpayne@17: for z in range(len(handle[i].alignments[j].hsps)): jpayne@17: hsp=handle[i].alignments[j].hsps[z] jpayne@17: temp=set(range(hsp.query_start,hsp.query_end)) jpayne@17: if len(cover_region)==0: jpayne@17: cover_region=cover_region|temp jpayne@17: fraction=1 jpayne@17: else: jpayne@17: fraction=1-len(cover_region&temp)/float(len(temp)) jpayne@17: cover_region=cover_region|temp jpayne@17: if "last" in handle[i].query or "first" in handle[i].query: jpayne@17: score+=hsp.bits*fraction jpayne@17: ids+=float(hsp.identities)/handle[i].query_length*fraction jpayne@17: else: jpayne@17: score+=hsp.bits*fraction jpayne@17: ids+=float(hsp.identities)/handle[i].query_length*fraction jpayne@17: List_score.append(score) jpayne@17: List_ids.append(ids) jpayne@17: List_query_region.append(cover_region) jpayne@17: temp=zip(List,List_score,List_ids,List_query_region) jpayne@17: Final_list=sorted(temp, key=lambda d:d[1], reverse = True) jpayne@17: return Final_list jpayne@17: jpayne@17: jpayne@17: def Uniq(L,sort_on_fre="none"): #return the uniq list and the count number jpayne@17: Old=L jpayne@17: L.sort() jpayne@17: L = [L[i] for i in range(len(L)) if L[i] not in L[:i]] jpayne@17: count=[] jpayne@17: for j in range(len(L)): jpayne@17: y=0 jpayne@17: for x in Old: jpayne@17: if L[j]==x: jpayne@17: y+=1 jpayne@17: count.append(y) jpayne@17: if sort_on_fre!="none": jpayne@17: d=zip(*sorted(zip(count, L))) jpayne@17: L=d[1] jpayne@17: count=d[0] jpayne@17: return (L,count) jpayne@17: jpayne@17: def judge_fliC_or_fljB_from_head_tail_for_one_contig(nodes_vs_score_list): jpayne@17: #used to predict it's fliC or fljB for one contig, based on tail and head score, but output the score difference,if it is very small, then not reliable, use blast score for whole contig to test jpayne@17: #this is mainly used for jpayne@17: a=nodes_vs_score_list jpayne@17: fliC_score=0 jpayne@17: fljB_score=0 jpayne@17: for z in a: jpayne@17: if "fliC" in z[0]: jpayne@17: fliC_score+=z[1] jpayne@17: elif "fljB" in z[0]: jpayne@17: fljB_score+=z[1] jpayne@17: if fliC_score>=fljB_score: jpayne@17: role="fliC" jpayne@17: else: jpayne@17: role="fljB" jpayne@17: return (role,abs(fliC_score-fljB_score)) jpayne@17: jpayne@17: def judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(node_name,Final_list,Final_list_passed): jpayne@17: #used to predict contig is fliC or fljB, if the differnce score value on above head_and_tail is less than 10 (quite small) jpayne@17: #also used when no head or tail got blasted score for the contig jpayne@17: role="" jpayne@17: for z in Final_list_passed: jpayne@17: if node_name in z[0]: jpayne@17: role=z[0].split("_")[0] jpayne@17: break jpayne@17: return role jpayne@17: jpayne@17: def fliC_or_fljB_judge_from_head_tail_sequence(nodes_list,tail_head_list,Final_list,Final_list_passed): jpayne@17: #nodes_list is the c created by c,d=Uniq(nodes) in below function jpayne@17: first_target="" jpayne@17: role_list=[] jpayne@17: for x in nodes_list: jpayne@17: a=[] jpayne@17: role="" jpayne@17: for y in tail_head_list: jpayne@17: if x in y[0]: jpayne@17: a.append(y) jpayne@17: if len(a)==4: jpayne@17: role,diff=judge_fliC_or_fljB_from_head_tail_for_one_contig(a) jpayne@17: if diff<20: jpayne@17: role=judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(x,Final_list,Final_list_passed) jpayne@17: elif len(a)==3: jpayne@17: ###however, if the one with highest score is the fewer one, compare their accumulation score jpayne@17: role,diff=judge_fliC_or_fljB_from_head_tail_for_one_contig(a) jpayne@17: if diff<20: jpayne@17: role=judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(x,Final_list,Final_list_passed) jpayne@17: ###end of above score comparison jpayne@17: elif len(a)==2: jpayne@17: #must on same node, if not, then decide with unit blast score, blast-score/length_of_special_sequence(30 or 37) jpayne@17: temp=[] jpayne@17: for z in a: jpayne@17: temp.append(z[0].split("_")[0]) jpayne@17: m,n=Uniq(temp)#should only have one choice, but weird situation might occur too jpayne@17: if len(m)==1: jpayne@17: pass jpayne@17: else: jpayne@17: pass jpayne@17: role,diff=judge_fliC_or_fljB_from_head_tail_for_one_contig(a) jpayne@17: if diff<20: jpayne@17: role=judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(x,Final_list,Final_list_passed) jpayne@17: ###need to desgin a algorithm to guess most possible situation for nodes_list, See the situations of test evaluation jpayne@17: elif len(a)==1: jpayne@17: #that one jpayne@17: role,diff=judge_fliC_or_fljB_from_head_tail_for_one_contig(a) jpayne@17: if diff<20: jpayne@17: role=judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(x,Final_list,Final_list_passed) jpayne@17: #need to evaluate, in future, may set up a cut-off, if not met, then just find Final_list_passed best match,like when "a==0" jpayne@17: else:#a==0 jpayne@17: #use Final_list_passed best match jpayne@17: for z in Final_list_passed: jpayne@17: if x in z[0]: jpayne@17: role=z[0].split("_")[0] jpayne@17: break jpayne@17: #print x,role,len(a) jpayne@17: role_list.append((role,x)) jpayne@17: if len(role_list)==2: jpayne@17: if role_list[0][0]==role_list[1][0]:#this is the most cocmmon error, two antigen were assigned to same phase jpayne@17: #just use score to do a final test jpayne@17: role_list=[] jpayne@17: for x in nodes_list: jpayne@17: role=judge_fliC_or_fljB_from_whole_contig_blast_score_ranking(x,Final_list,Final_list_passed) jpayne@17: role_list.append((role,x)) jpayne@17: return role_list jpayne@17: jpayne@17: def decide_contig_roles_for_H_antigen(Final_list,Final_list_passed): jpayne@17: #used to decide which contig is FliC and which one is fljB jpayne@17: contigs=[] jpayne@17: nodes=[] jpayne@17: for x in Final_list_passed: jpayne@17: if x[0].startswith("fl") and "last" not in x[0] and "first" not in x[0]: jpayne@17: nodes.append(x[0].split("___")[1].strip()) jpayne@17: c,d=Uniq(nodes)#c is node_list jpayne@17: #print c jpayne@17: tail_head_list=[x for x in Final_list if ("last" in x[0] or "first" in x[0])] jpayne@17: roles=fliC_or_fljB_judge_from_head_tail_sequence(c,tail_head_list,Final_list,Final_list_passed) jpayne@17: return roles jpayne@17: jpayne@17: def decide_O_type_and_get_special_genes(Final_list,Final_list_passed): jpayne@17: #decide O based on Final_list jpayne@17: O_choice="?" jpayne@17: O_list=[] jpayne@17: special_genes={} jpayne@17: nodes=[] jpayne@17: for x in Final_list_passed: jpayne@17: if x[0].startswith("O-"): jpayne@17: nodes.append(x[0].split("___")[1].strip()) jpayne@17: elif not x[0].startswith("fl"): jpayne@17: special_genes[x[0]]=x[2]#08172018, x[2] changed from x[-1] jpayne@17: #print "special_genes:",special_genes jpayne@17: c,d=Uniq(nodes) jpayne@17: #print "potential O antigen contig",c jpayne@17: final_O=[] jpayne@17: O_nodes_list=[] jpayne@17: for x in c:#c is the list for contigs jpayne@17: temp=0 jpayne@17: for y in Final_list_passed: jpayne@17: if x in y[0] and y[0].startswith("O-"): jpayne@17: final_O.append(y) jpayne@17: break jpayne@17: ### O contig has the problem of two genes on same contig, so do additional test jpayne@17: potenial_new_gene="" jpayne@17: for x in final_O: jpayne@17: pointer=0 #for genes merged or not jpayne@17: #not consider O-1,3,19_not_in_3,10, too short compared with others jpayne@17: if "O-1,3,19_not_in_3,10" not in x[0] and int(x[0].split("__")[1].split("___")[0])*x[2]+850 <= int(x[0].split("length_")[1].split("_")[0]):#gene length << contig length; for now give 300*2 (for secureity can use 400*2) as flank region jpayne@17: pointer=x[0].split("___")[1].strip()#store the contig name jpayne@17: print(pointer) jpayne@17: if pointer!=0:#it has potential merge event jpayne@17: for y in Final_list: jpayne@17: if pointer in y[0] and y not in final_O and (y[1]>=int(y[0].split("__")[1].split("___")[0])*1.5 or (y[1]>=int(y[0].split("__")[1].split("___")[0])*y[2] and y[1]>=400)):#that's a realtively strict filter now; if passed, it has merge event and add one more to final_O jpayne@17: potenial_new_gene=y jpayne@17: #print(potenial_new_gene) jpayne@17: break jpayne@17: if potenial_new_gene!="": jpayne@17: print("two differnt genes in same contig, fix it for O antigen") jpayne@17: print(potenial_new_gene[:3]) jpayne@17: pointer=0 jpayne@17: for y in final_O: jpayne@17: if y[0].split("___")[-1]==potenial_new_gene[0].split("___")[-1]: jpayne@17: pointer=1 jpayne@17: if pointer!=0: #changed to consider two genes in same contig jpayne@17: final_O.append(potenial_new_gene) jpayne@17: ### end of the two genes on same contig test jpayne@17: final_O=sorted(final_O,key=lambda x: x[2], reverse=True)#sorted jpayne@17: if len(final_O)==0 or (len(final_O)==1 and "O-1,3,19_not_in_3,10" in final_O[0][0]): jpayne@17: #print "$$$No Otype, due to no hit"#may need to be changed jpayne@17: O_choice="-" jpayne@17: else: jpayne@17: highest_O_coverage=max([float(x[0].split("_cov_")[-1].split("_")[0]) for x in final_O if "O-1,3,19_not_in_3,10" not in x[0]]) jpayne@17: O_list=[] jpayne@17: O_list_less_contamination=[] jpayne@17: for x in final_O: jpayne@17: if not "O-1,3,19_not_in_3,10__130" in x[0]:#O-1,3,19_not_in_3,10 is too small, which may affect further analysis; to avoid contamination affect, use 0.15 of highest coverage as cut-off jpayne@17: O_list.append(x[0].split("__")[0]) jpayne@17: O_nodes_list.append(x[0].split("___")[1]) jpayne@17: if float(x[0].split("_cov_")[-1].split("_")[0])>highest_O_coverage*0.15: jpayne@17: O_list_less_contamination.append(x[0].split("__")[0]) jpayne@17: ### special test for O9,46 and O3,10 family jpayne@17: if ("O-9,46_wbaV" in O_list or "O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254" in O_list) and O_list_less_contamination[0].startswith("O-9,"):#not sure should use and float(O9_wbaV)/float(num_1) > 0.1 jpayne@17: if "O-9,46_wzy" in O_list or "O-9,46_wzy_partial" in O_list:#and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: O_choice="O-9,46" jpayne@17: #print "$$$Most possilble Otype: O-9,46" jpayne@17: elif "O-9,46,27_partial_wzy" in O_list:#and float(O94627)/float(num_1) > 0.1 jpayne@17: O_choice="O-9,46,27" jpayne@17: #print "$$$Most possilble Otype: O-9,46,27" jpayne@17: else: jpayne@17: O_choice="O-9"#next, detect O9 vs O2? jpayne@17: O2=0 jpayne@17: O9=0 jpayne@17: for z in special_genes: jpayne@17: if "tyr-O-9" in z and special_genes[z] > O9: ##20240322, add "special_genes[z] > O9" to avoid misidentification of O9 to O2 that caused by multiple tyr-O-9 contigs jpayne@17: O9=special_genes[z] jpayne@17: elif "tyr-O-2" in z and special_genes[z] > O2: ##20240322, add "special_genes[z] > O2" jpayne@17: O2=special_genes[z] jpayne@17: if O2>O9: jpayne@17: O_choice="O-2" jpayne@17: elif O2 0.1 and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: if "O-3,10_not_in_1,3,19" in O_list:#and float(O310_no_1319)/float(num_1) > 0.1 jpayne@17: O_choice="O-3,10" jpayne@17: #print "$$$Most possilble Otype: O-3,10 (contain O-3,10_not_in_1,3,19)" jpayne@17: else: jpayne@17: O_choice="O-1,3,19" jpayne@17: #print "$$$Most possilble Otype: O-1,3,19 (not contain O-3,10_not_in_1,3,19)" jpayne@17: ### end of special test for O9,46 and O3,10 family jpayne@17: else: jpayne@17: try: jpayne@17: max_score=0 jpayne@17: for x in final_O: jpayne@17: if x[2]>=max_score and float(x[0].split("_cov_")[-1].split("_")[0])>highest_O_coverage*0.15:#use x[2],08172018, the "coverage identity = cover_length * identity"; also meet coverage threshold jpayne@17: max_score=x[2]#change from x[-1] to x[2],08172018 jpayne@17: O_choice=x[0].split("_")[0] jpayne@17: if O_choice=="O-1,3,19": jpayne@17: O_choice=final_O[1][0].split("_")[0] jpayne@17: #print "$$$Most possilble Otype: ",O_choice jpayne@17: except: jpayne@17: pass jpayne@17: #print "$$$No suitable Otype, or failure of mapping (please check the quality of raw reads)" jpayne@17: if O_choice=="O-9,46,27" and len(O_list)==2 and "O-4_wzx" in O_list: #special for very low chance sitatuion between O4 and O9,27,46, this is for serotypes like Bredeney and Schwarzengrund (normallly O-4 will have higher score, but sometimes sequencing quality may affect the prediction) jpayne@17: O_choice="O-4" jpayne@17: #print "O:",O_choice,O_nodes_list jpayne@17: Otypes=[] jpayne@17: for x in O_list: jpayne@17: if x!="O-1,3,19_not_in_3,10": jpayne@17: if "O-9,46_" not in x: jpayne@17: Otypes.append(x.split("_")[0]) jpayne@17: else: jpayne@17: Otypes.append(x.split("-from")[0])#O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254 jpayne@17: #Otypes=[x.split("_")[0] for x in O_list if x!="O-1,3,19_not_in_3,10"] jpayne@17: Otypes_uniq,Otypes_fre=Uniq(Otypes) jpayne@17: contamination_O="" jpayne@17: if O_choice=="O-9,46,27" or O_choice=="O-3,10" or O_choice=="O-1,3,19": jpayne@17: if len(Otypes_uniq)>2: jpayne@17: contamination_O="potential contamination from O antigen signals" jpayne@17: else: jpayne@17: if len(Otypes_uniq)>1: jpayne@17: if O_choice=="O-4" and len(Otypes_uniq)==2 and "O-9,46,27" in Otypes_uniq: #for special 4,12,27 case such as Bredeney and Schwarzengrund jpayne@17: contamination_O="" jpayne@17: elif O_choice=="O-9,46" and len(Otypes_uniq)==2 and "O-9,46_wbaV" in Otypes_uniq and "O-9,46_wzy" in Otypes_uniq: #for special 4,12,27 case such as Bredeney and Schwarzengrund jpayne@17: contamination_O="" jpayne@17: else: jpayne@17: contamination_O="potential contamination from O antigen signals" jpayne@17: return O_choice,O_nodes_list,special_genes,final_O,contamination_O,Otypes_uniq jpayne@17: ### End of SeqSero2 allele prediction and output jpayne@17: jpayne@17: def get_input_files(make_dir,input_file,data_type,dirpath): jpayne@17: #tell input files from datatype jpayne@17: #": '1'(pair-end reads, interleaved),'2'(pair-end reads, seperated),'3'(single-end reads), '4'(assembly),'5'(nanopore fasta),'6'(nanopore fastq)" jpayne@17: for_fq="" jpayne@17: rev_fq="" jpayne@17: os.chdir(make_dir) jpayne@17: if data_type=="1": jpayne@17: input_file=input_file[0].split("/")[-1] jpayne@17: if input_file.endswith(".sra"): jpayne@17: subprocess.check_call("fastq-dump --split-files "+input_file,shell=True) jpayne@17: for_fq=input_file.replace(".sra","_1.fastq") jpayne@17: rev_fq=input_file.replace(".sra","_2.fastq") jpayne@17: else: jpayne@17: core_id=input_file.split(".fastq")[0].split(".fq")[0] jpayne@17: for_fq=core_id+"_1.fastq" jpayne@17: rev_fq=core_id+"_2.fastq" jpayne@17: if input_file.endswith(".gz"): jpayne@17: subprocess.check_call("gzip -dc "+input_file+" | "+dirpath+"/deinterleave_fastq.sh "+for_fq+" "+rev_fq,shell=True) jpayne@17: else: jpayne@17: subprocess.check_call("cat "+input_file+" | "+dirpath+"/deinterleave_fastq.sh "+for_fq+" "+rev_fq,shell=True) jpayne@17: elif data_type=="2": jpayne@17: for_fq=input_file[0].split("/")[-1] jpayne@17: rev_fq=input_file[1].split("/")[-1] jpayne@17: elif data_type=="3": jpayne@17: input_file=input_file[0].split("/")[-1] jpayne@17: if input_file.endswith(".sra"): jpayne@17: subprocess.check_call("fastq-dump --split-files "+input_file,shell=True) jpayne@17: for_fq=input_file.replace(".sra","_1.fastq") jpayne@17: else: jpayne@17: for_fq=input_file jpayne@17: elif data_type in ["4","5","6"]: jpayne@17: for_fq=input_file[0].split("/")[-1] jpayne@17: os.chdir("..") jpayne@17: return for_fq,rev_fq jpayne@17: jpayne@17: def predict_O_and_H_types(Final_list,Final_list_passed,new_fasta): jpayne@17: #get O and H types from Final_list from blast parsing; allele mode jpayne@17: from Bio import SeqIO jpayne@17: fliC_choice="-" jpayne@17: fljB_choice="-" jpayne@17: fliC_contig="NA" jpayne@17: fljB_contig="NA" jpayne@17: fliC_region=set([0]) jpayne@17: fljB_region=set([0,]) jpayne@17: fliC_length=0 #can be changed to coverage in future; in 03292019, changed to ailgned length jpayne@17: fljB_length=0 #can be changed to coverage in future; in 03292019, changed to ailgned length jpayne@17: O_choice="-"#no need to decide O contig for now, should be only one jpayne@17: O_choice,O_nodes,special_gene_list,O_nodes_roles,contamination_O,Otypes_uniq=decide_O_type_and_get_special_genes(Final_list,Final_list_passed)#decide the O antigen type and also return special-gene-list for further identification jpayne@17: O_choice=O_choice.split("-")[-1].strip() jpayne@17: if (O_choice=="1,3,19" and len(O_nodes_roles)==1 and "1,3,19" in O_nodes_roles[0][0]) or O_choice=="": jpayne@17: O_choice="-" jpayne@17: H_contig_roles=decide_contig_roles_for_H_antigen(Final_list,Final_list_passed)#decide the H antigen contig is fliC or fljB jpayne@17: #add alignment locations, used for further selection, 03312019 jpayne@17: for i in range(len(H_contig_roles)): jpayne@17: x=H_contig_roles[i] jpayne@17: for y in Final_list_passed: jpayne@17: if x[1] in y[0] and y[0].startswith(x[0]): jpayne@17: H_contig_roles[i]+=H_contig_roles[i]+(y[-1],) jpayne@17: break jpayne@17: log_file=open("SeqSero_log.txt","a") jpayne@17: extract_file=open("Extracted_antigen_alleles.fasta","a") jpayne@17: handle_fasta=list(SeqIO.parse(new_fasta,"fasta")) jpayne@17: jpayne@17: #print("O_contigs:") jpayne@17: log_file.write("O_contigs:\n") jpayne@17: extract_file.write("#Sequences with antigen signals (if the micro-assembled contig only covers the flanking region, it will not be used for contamination analysis)\n") jpayne@17: extract_file.write("#O_contigs:\n") jpayne@17: for x in O_nodes_roles: jpayne@17: if "O-1,3,19_not_in_3,10" not in x[0]:#O-1,3,19_not_in_3,10 is just a small size marker jpayne@17: #print(x[0].split("___")[-1],x[0].split("__")[0],"blast score:",x[1],"identity%:",str(round(x[2]*100,2))+"%",str(min(x[-1]))+" to "+str(max(x[-1]))) jpayne@17: log_file.write(x[0].split("___")[-1]+" "+x[0].split("__")[0]+"; "+"blast score: "+str(x[1])+" identity%: "+str(round(x[2]*100,2))+"%; alignment from "+str(min(x[-1]))+" to "+str(max(x[-1]))+" of antigen\n") jpayne@17: title=">"+x[0].split("___")[-1]+" "+x[0].split("__")[0]+"; "+"blast score: "+str(x[1])+" identity%: "+str(round(x[2]*100,2))+"%; alignment from "+str(min(x[-1]))+" to "+str(max(x[-1]))+" of antigen\n" jpayne@17: seqs="" jpayne@17: for z in handle_fasta: jpayne@17: if x[0].split("___")[-1]==z.description: jpayne@17: seqs=str(z.seq) jpayne@17: extract_file.write(title+seqs+"\n") jpayne@17: if len(H_contig_roles)!=0: jpayne@17: highest_H_coverage=max([float(x[1].split("_cov_")[-1].split("_")[0]) for x in H_contig_roles]) #less than highest*0.1 would be regarded as contamination and noises, they will still be considered in contamination detection and logs, but not used as final serotype output jpayne@17: else: jpayne@17: highest_H_coverage=0 jpayne@17: for x in H_contig_roles: jpayne@17: #if multiple choices, temporately select the one with longest length for now, will revise in further change jpayne@17: if "fliC" == x[0] and len(x[-1])>=fliC_length and x[1] not in O_nodes and float(x[1].split("_cov_")[-1].split("_")[0])>highest_H_coverage*0.13:#remember to avoid the effect of O-type contig, so should not in O_node list jpayne@17: fliC_contig=x[1] jpayne@17: fliC_length=len(x[-1]) jpayne@17: elif "fljB" == x[0] and len(x[-1])>=fljB_length and x[1] not in O_nodes and float(x[1].split("_cov_")[-1].split("_")[0])>highest_H_coverage*0.13: jpayne@17: fljB_contig=x[1] jpayne@17: fljB_length=len(x[-1]) jpayne@17: for x in Final_list_passed: jpayne@17: if fliC_choice=="-" and "fliC_" in x[0] and fliC_contig in x[0]: jpayne@17: fliC_choice=x[0].split("_")[1] jpayne@17: elif fljB_choice=="-" and "fljB_" in x[0] and fljB_contig in x[0]: jpayne@17: fljB_choice=x[0].split("_")[1] jpayne@17: elif fliC_choice!="-" and fljB_choice!="-": jpayne@17: break jpayne@17: #now remove contigs not in middle core part jpayne@17: first_allele="NA" jpayne@17: first_allele_percentage=0 jpayne@17: for x in Final_list: jpayne@17: if x[0].startswith("fliC") or x[0].startswith("fljB"): jpayne@17: first_allele=x[0].split("__")[0] #used to filter those un-middle contigs jpayne@17: first_allele_percentage=x[2] jpayne@17: break jpayne@17: additional_contigs=[] jpayne@17: for x in Final_list: jpayne@17: if first_allele in x[0]: jpayne@17: if (fliC_contig == x[0].split("___")[-1]): jpayne@17: fliC_region=x[3] jpayne@17: elif fljB_contig!="NA" and (fljB_contig == x[0].split("___")[-1]): jpayne@17: fljB_region=x[3] jpayne@17: else: jpayne@17: if x[1]*1.1>int(x[0].split("___")[1].split("_")[3]):#loose threshold by multiplying 1.1 jpayne@17: additional_contigs.append(x) jpayne@17: #else: jpayne@17: #print x[:3] jpayne@17: #we can just use the fljB region (or fliC depends on size), no matter set() or contain a large locations (without middle part); however, if none of them is fully assembled, use 500 and 1200 as conservative cut-off jpayne@17: if first_allele_percentage>0.9: jpayne@17: if len(fliC_region)>len(fljB_region) and (max(fljB_region)-min(fljB_region))>1000: jpayne@17: target_region=fljB_region|(fliC_region-set(range(min(fljB_region),max(fljB_region)))) #fljB_region|(fliC_region-set(range(min(fljB_region),max(fljB_region)))) jpayne@17: elif len(fliC_region)1000: jpayne@17: target_region=fliC_region|(fljB_region-set(range(min(fliC_region),max(fliC_region)))) #fljB_region|(fliC_region-set(range(min(fljB_region),max(fljB_region)))) jpayne@17: else: jpayne@17: target_region=set()#doesn't do anything jpayne@17: else: jpayne@17: target_region=set()#doesn't do anything jpayne@17: #print(target_region) jpayne@17: #print(additional_contigs) jpayne@17: target_region2=set(list(range(0,525))+list(range(1200,1700)))#I found to use 500 to 1200 as special region would be best jpayne@17: target_region=target_region2|target_region jpayne@17: for x in additional_contigs: jpayne@17: removal=0 jpayne@17: contig_length=int(x[0].split("___")[1].split("length_")[-1].split("_")[0]) jpayne@17: if fljB_contig not in x[0] and fliC_contig not in x[0] and len(target_region&x[3])/float(len(x[3]))>0.65 and contig_length*0.5 0.9 and float(x[0].split("__")[1].split("___")[0])*x[2]/len(x[-1])>0.96:#if high similiarity with middle part of first allele (first allele >0.9, already cover middle part) jpayne@17: removal=1 jpayne@17: else: jpayne@17: pass jpayne@17: if removal==1: jpayne@17: for y in H_contig_roles: jpayne@17: if y[1] in x[0]: jpayne@17: H_contig_roles.remove(y) jpayne@17: else: jpayne@17: pass jpayne@17: #print(x[:3],contig_length,len(target_region&x[3])/float(len(x[3])),contig_length*0.5,len(x[3]),contig_length*1.5) jpayne@17: #end of removing none-middle contigs jpayne@17: #print("H_contigs:") jpayne@17: log_file.write("H_contigs:\n") jpayne@17: extract_file.write("#H_contigs:\n") jpayne@17: H_contig_stat=[] jpayne@17: H1_cont_stat={} jpayne@17: H2_cont_stat={} jpayne@17: for i in range(len(H_contig_roles)): jpayne@17: x=H_contig_roles[i] jpayne@17: a=0 jpayne@17: for y in Final_list_passed: jpayne@17: if x[1] in y[0] and y[0].startswith(x[0]): jpayne@17: if "first" in y[0] or "last" in y[0]: #this is the final filter to decide it's fliC or fljB, if can't pass, then can't decide jpayne@17: for y in Final_list_passed: #it's impossible to has the "first" and "last" allele as prediction, so re-do it jpayne@17: if x[1] in y[0]:#it's very possible to be third phase allele, so no need to make it must be fliC or fljB jpayne@17: #print(x[1],"can't_decide_fliC_or_fljB",y[0].split("_")[1],"blast_score:",y[1],"identity%:",str(round(y[2]*100,2))+"%",str(min(y[-1]))+" to "+str(max(y[-1]))) jpayne@17: log_file.write(x[1]+" "+x[0]+" "+y[0].split("_")[1]+"; "+"blast score: "+str(y[1])+" identity%: "+str(round(y[2]*100,2))+"%; alignment from "+str(min(y[-1]))+" to "+str(max(y[-1]))+" of antigen\n") jpayne@17: H_contig_roles[i]="can't decide fliC or fljB, may be third phase" jpayne@17: title=">"+x[1]+" "+x[0]+" "+y[0].split("_")[1]+"; "+"blast score: "+str(y[1])+" identity%: "+str(round(y[2]*100,2))+"%; alignment from "+str(min(y[-1]))+" to "+str(max(y[-1]))+" of antiten\n" jpayne@17: seqs="" jpayne@17: for z in handle_fasta: jpayne@17: if x[1]==z.description: jpayne@17: seqs=str(z.seq) jpayne@17: extract_file.write(title+seqs+"\n") jpayne@17: break jpayne@17: else: jpayne@17: #print(x[1],x[0],y[0].split("_")[1],"blast_score:",y[1],"identity%:",str(round(y[2]*100,2))+"%",str(min(y[-1]))+" to "+str(max(y[-1]))) jpayne@17: log_file.write(x[1]+" "+x[0]+" "+y[0].split("_")[1]+"; "+"blast score: "+str(y[1])+" identity%: "+str(round(y[2]*100,2))+"%; alignment from "+str(min(y[-1]))+" to "+str(max(y[-1]))+" of antigen\n") jpayne@17: title=">"+x[1]+" "+x[0]+" "+y[0].split("_")[1]+"; "+"blast score: "+str(y[1])+" identity%: "+str(round(y[2]*100,2))+"%; alignment from "+str(min(y[-1]))+" to "+str(max(y[-1]))+" of antigen\n" jpayne@17: seqs="" jpayne@17: for z in handle_fasta: jpayne@17: if x[1]==z.description: jpayne@17: seqs=str(z.seq) jpayne@17: extract_file.write(title+seqs+"\n") jpayne@17: if x[0]=="fliC": jpayne@17: if y[0].split("_")[1] not in H1_cont_stat: jpayne@17: H1_cont_stat[y[0].split("_")[1]]=y[2] jpayne@17: else: jpayne@17: H1_cont_stat[y[0].split("_")[1]]+=y[2] jpayne@17: if x[0]=="fljB": jpayne@17: if y[0].split("_")[1] not in H2_cont_stat: jpayne@17: H2_cont_stat[y[0].split("_")[1]]=y[2] jpayne@17: else: jpayne@17: H2_cont_stat[y[0].split("_")[1]]+=y[2] jpayne@17: break jpayne@17: #detect contaminations jpayne@17: #print(H1_cont_stat) jpayne@17: #print(H2_cont_stat) jpayne@17: H1_cont_stat_list=[x for x in H1_cont_stat if H1_cont_stat[x]>0.2] jpayne@17: H2_cont_stat_list=[x for x in H2_cont_stat if H2_cont_stat[x]>0.2] jpayne@17: contamination_H="" jpayne@17: if len(H1_cont_stat_list)>1 or len(H2_cont_stat_list)>1: jpayne@17: contamination_H="potential contamination from H antigen signals" jpayne@17: elif len(H2_cont_stat_list)==1 and fljB_contig=="NA": jpayne@17: contamination_H="potential contamination from H antigen signals, uncommon weak fljB signals detected" jpayne@17: #get additional antigens jpayne@17: """ jpayne@17: if ("O-9,46_wbaV" in O_list or "O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254" in O_list) and O_list_less_contamination[0].startswith("O-9,"):#not sure should use and float(O9_wbaV)/float(num_1) > 0.1 jpayne@17: if "O-9,46_wzy" in O_list:#and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: O_choice="O-9,46" jpayne@17: #print "$$$Most possilble Otype: O-9,46" jpayne@17: elif "O-9,46,27_partial_wzy" in O_list:#and float(O94627)/float(num_1) > 0.1 jpayne@17: O_choice="O-9,46,27" jpayne@17: #print "$$$Most possilble Otype: O-9,46,27" jpayne@17: elif ("O-3,10_wzx" in O_list) and ("O-9,46_wzy" in O_list) and (O_list[0].startswith("O-3,10") or O_list_less_contamination[0].startswith("O-9,46_wzy")):#and float(O310_wzx)/float(num_1) > 0.1 and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: if "O-3,10_not_in_1,3,19" in O_list:#and float(O310_no_1319)/float(num_1) > 0.1 jpayne@17: O_choice="O-3,10" jpayne@17: #print "$$$Most possilble Otype: O-3,10 (contain O-3,10_not_in_1,3,19)" jpayne@17: else: jpayne@17: O_choice="O-1,3,19" jpayne@17: #print "$$$Most possilble Otype: O-1,3,19 (not contain O-3,10_not_in_1,3,19)" jpayne@17: ### end of special test for O9,46 and O3,10 family jpayne@17: jpayne@17: if O_choice=="O-9,46,27" or O_choice=="O-3,10" or O_choice=="O-1,3,19": jpayne@17: if len(Otypes_uniq)>2: jpayne@17: contamination_O="potential contamination from O antigen signals" jpayne@17: else: jpayne@17: if len(Otypes_uniq)>1: jpayne@17: if O_choice=="O-4" and len(Otypes_uniq)==2 and "O-9,46,27" in Otypes_uniq: #for special 4,12,27 case such as Bredeney and Schwarzengrund jpayne@17: contamination_O="" jpayne@17: elif O_choice=="O-9,46" and len(Otypes_uniq)==2 and "O-9,46_wbaV" in Otypes_uniq and "O-9,46_wzy" in Otypes_uniq: #for special 4,12,27 case such as Bredeney and Schwarzengrund jpayne@17: contamination_O="" jpayne@17: """ jpayne@17: additonal_antigents=[] jpayne@17: #print(contamination_O) jpayne@17: #print(contamination_H) jpayne@17: log_file.write(contamination_O+"\n") jpayne@17: log_file.write(contamination_H+"\n") jpayne@17: log_file.close() jpayne@17: return O_choice,fliC_choice,fljB_choice,special_gene_list,contamination_O,contamination_H,Otypes_uniq,H1_cont_stat_list,H2_cont_stat_list jpayne@17: jpayne@17: def get_input_K(input_file,lib_dict,data_type,k_size): jpayne@17: #kmer mode; get input_Ks from dict and data_type jpayne@17: kmers = [] jpayne@17: for h in lib_dict: jpayne@17: kmers += lib_dict[h] jpayne@17: if data_type == '4': jpayne@17: input_Ks = target_multifasta_kmerizer(input_file, k_size, set(kmers)) jpayne@17: elif data_type == '1' or data_type == '2' or data_type == '3':#set it for now, will change later jpayne@17: input_Ks = target_read_kmerizer(input_file, k_size, set(kmers)) jpayne@17: elif data_type == '5':#minion_2d_fasta jpayne@17: #input_Ks = minion_fasta_kmerizer(input_file, k_size, set(kmers)) jpayne@17: input_Ks = target_multifasta_kmerizer(input_file, k_size, set(kmers)) #ed_SL_08172020: change for nanopore workflow jpayne@17: if data_type == '6':#minion_2d_fastq jpayne@17: input_Ks = minion_fastq_kmerizer(input_file, k_size, set(kmers)) jpayne@17: return input_Ks jpayne@17: jpayne@17: def get_kmer_dict(lib_dict,input_Ks): jpayne@17: #kmer mode; get predicted types jpayne@17: O_dict = {} jpayne@17: H_dict = {} jpayne@17: Special_dict = {} jpayne@17: for h in lib_dict: jpayne@17: score = (len(lib_dict[h] & input_Ks) / len(lib_dict[h])) * 100 jpayne@17: if score > 1: # Arbitrary cut-off for similarity score very low but seems necessary to detect O-3,10 in some cases jpayne@17: if h.startswith('O-') and score > 25: jpayne@17: O_dict[h] = score jpayne@17: if h.startswith('fl') and score > 40: jpayne@17: H_dict[h] = score jpayne@17: if (h[:2] != 'fl') and (h[:2] != 'O-'): jpayne@17: Special_dict[h] = score jpayne@17: return O_dict,H_dict,Special_dict jpayne@17: jpayne@17: def call_O_and_H_type(O_dict,H_dict,Special_dict,make_dir): jpayne@17: log_file=open("SeqSero_log.txt","a") jpayne@17: log_file.write("O_scores:\n") jpayne@17: #call O: jpayne@17: highest_O = '-' jpayne@17: if len(O_dict) == 0: jpayne@17: pass jpayne@17: else: jpayne@17: for x in O_dict: jpayne@17: log_file.write(x+"\t"+str(O_dict[x])+"\n") jpayne@17: if ('O-9,46_wbaV__1002' in O_dict and O_dict['O-9,46_wbaV__1002']>70) or ("O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254__1002" in O_dict and O_dict['O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254__1002']>70): # not sure should use and float(O9_wbaV)/float(num_1) > 0.1 jpayne@17: #if 'O-9,46_wzy__1191' in O_dict or "O-9,46_wzy_partial__216" in O_dict: # and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: #modified to fix miscall of O-9,46 jpayne@17: if ('O-9,46_wzy__1191' in O_dict and O_dict['O-9,46_wzy__1191']>40) or ("O-9,46_wzy_partial__216" in O_dict and O_dict["O-9,46_wzy_partial__216"]>40): # and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: highest_O = "O-9,46" jpayne@17: elif "O-9,46,27_partial_wzy__1019" in O_dict: # and float(O94627)/float(num_1) > 0.1 jpayne@17: highest_O = "O-9,46,27" jpayne@17: else: jpayne@17: highest_O = "O-9" # next, detect O9 vs O2? jpayne@17: O2 = 0 jpayne@17: O9 = 0 jpayne@17: for z in Special_dict: jpayne@17: if "tyr-O-9" in z: jpayne@17: O9 = float(Special_dict[z]) jpayne@17: if "tyr-O-2" in z: jpayne@17: O2 = float(Special_dict[z]) jpayne@17: if O2 > O9: jpayne@17: highest_O = "O-2" jpayne@17: elif ("O-3,10_wzx__1539" in O_dict) and ( jpayne@17: "O-9,46_wzy__1191" in O_dict jpayne@17: ): # and float(O310_wzx)/float(num_1) > 0.1 and float(O946_wzy)/float(num_1) > 0.1 jpayne@17: if "O-3,10_not_in_1,3,19__1519" in O_dict: # and float(O310_no_1319)/float(num_1) > 0.1 jpayne@17: highest_O = "O-3,10" jpayne@17: else: jpayne@17: highest_O = "O-1,3,19" jpayne@17: ### end of special test for O9,46 and O3,10 family jpayne@17: else: jpayne@17: try: jpayne@17: max_score = 0 jpayne@17: for x in O_dict: jpayne@17: if float(O_dict[x]) >= max_score: jpayne@17: max_score = float(O_dict[x]) jpayne@17: #highest_O = x.split("_")[0] jpayne@17: # ed_SL_12182019: modified to fix the O-9,46 error example1 jpayne@17: if (x == 'O-9,46_wbaV__1002' or x == 'O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254__1002') and ('O-9,46_wzy__1191' not in O_dict and 'O-9,46_wzy_partial__216' not in O_dict): jpayne@17: highest_O = "O-9" jpayne@17: else: jpayne@17: highest_O = x.split("_")[0] jpayne@17: if highest_O == "O-1,3,19": jpayne@17: highest_O = '-' jpayne@17: max_score = 0 jpayne@17: for x in O_dict: jpayne@17: if x == 'O-1,3,19_not_in_3,10__130': jpayne@17: pass jpayne@17: else: jpayne@17: if float(O_dict[x]) >= max_score: jpayne@17: max_score = float(O_dict[x]) jpayne@17: #highest_O = x.split("_")[0] jpayne@17: # ed_SL_12182019: modified to fix the O-9,46 error example1 jpayne@17: if (x == 'O-9,46_wbaV__1002' or x == 'O-9,46_wbaV-from-II-9,12:z29:1,5-SRR1346254__1002') and ('O-9,46_wzy__1191' not in O_dict and 'O-9,46_wzy_partial__216' not in O_dict): jpayne@17: highest_O = "O-9" jpayne@17: else: jpayne@17: highest_O = x.split("_")[0] jpayne@17: except: jpayne@17: pass jpayne@17: #call_fliC: jpayne@17: if len(H_dict)!=0: jpayne@17: highest_H_score_both_BC=H_dict[max(H_dict.keys(), key=(lambda k: H_dict[k]))] #used to detect whether fljB existed or not jpayne@17: else: jpayne@17: highest_H_score_both_BC=0 jpayne@17: highest_fliC = '-' jpayne@17: highest_fliC_raw = '-' jpayne@17: highest_Score = 0 jpayne@17: log_file.write("\nH_scores:\n") jpayne@17: for s in H_dict: jpayne@17: log_file.write(s+"\t"+str(H_dict[s])+"\n") jpayne@17: if s.startswith('fliC'): jpayne@17: if float(H_dict[s]) > highest_Score: jpayne@17: highest_fliC = s.split('_')[1] jpayne@17: highest_fliC_raw = s jpayne@17: highest_Score = float(H_dict[s]) jpayne@17: #call_fljB jpayne@17: highest_fljB = '-' jpayne@17: highest_fljB_raw = '-' jpayne@17: highest_Score = 0 jpayne@17: for s in H_dict: jpayne@17: if s.startswith('fljB'): jpayne@17: if float(H_dict[s]) > highest_Score and float(H_dict[s]) > highest_H_score_both_BC * 0.65: #fljB is special, so use highest_H_score_both_BC to give a general estimate of coverage, currently 0.65 seems pretty good; the reason use a high (0.65) is some fliC and fljB shared with each other jpayne@17: #highest_fljB = s.split('_')[1] jpayne@17: #highest_fljB_raw = s jpayne@17: #highest_Score = float(H_dict[s]) jpayne@17: if s.split('_')[1]!=highest_fliC: jpayne@17: highest_fljB = s.split('_')[1] jpayne@17: highest_fljB_raw = s jpayne@17: highest_Score = float(H_dict[s]) jpayne@17: log_file.write("\nSpecial_scores:\n") jpayne@17: for s in Special_dict: jpayne@17: log_file.write(s+"\t"+str(Special_dict[s])+"\n") jpayne@17: log_file.close() jpayne@17: return highest_O,highest_fliC,highest_fljB jpayne@17: jpayne@17: def get_temp_file_names(for_fq,rev_fq): jpayne@17: #seqsero2 -a; get temp file names jpayne@17: sam=for_fq+".sam" jpayne@17: bam=for_fq+".bam" jpayne@17: sorted_bam=for_fq+"_sorted.bam" jpayne@17: mapped_fq1=for_fq+"_mapped.fq" jpayne@17: mapped_fq2=rev_fq+"_mapped.fq" jpayne@17: combined_fq=for_fq+"_combined.fq" jpayne@17: for_sai=for_fq+".sai" jpayne@17: rev_sai=rev_fq+".sai" jpayne@17: return sam,bam,sorted_bam,mapped_fq1,mapped_fq2,combined_fq,for_sai,rev_sai jpayne@17: jpayne@17: def map_and_sort(threads,database,fnameA,fnameB,sam,bam,for_sai,rev_sai,sorted_bam,mapping_mode): jpayne@17: #seqsero2 -a; do mapping and sort jpayne@17: print("building database...") jpayne@17: subprocess.check_call("bwa index "+database+ " 2>> data_log.txt",shell=True) jpayne@17: print("mapping...") jpayne@17: if mapping_mode=="mem": jpayne@17: subprocess.check_call("bwa mem -k 17 -t "+threads+" "+database+" "+fnameA+" "+fnameB+" > "+sam+ " 2>> data_log.txt",shell=True) jpayne@17: elif mapping_mode=="sam": jpayne@17: if fnameB!="": jpayne@17: subprocess.check_call("bwa aln -t "+threads+" "+database+" "+fnameA+" > "+for_sai+ " 2>> data_log.txt",shell=True) jpayne@17: subprocess.check_call("bwa aln -t "+threads+" "+database+" "+fnameB+" > "+rev_sai+ " 2>> data_log.txt",shell=True) jpayne@17: subprocess.check_call("bwa sampe "+database+" "+for_sai+" "+ rev_sai+" "+fnameA+" "+fnameB+" > "+sam+ " 2>> data_log.txt",shell=True) jpayne@17: else: jpayne@17: subprocess.check_call("bwa aln -t "+threads+" "+database+" "+fnameA+" > "+for_sai+ " 2>> data_log.txt",shell=True) jpayne@17: subprocess.check_call("bwa samse "+database+" "+for_sai+" "+for_fq+" > "+sam) jpayne@17: subprocess.check_call("samtools view -@ "+threads+" -F 4 -Sh "+sam+" > "+bam,shell=True) jpayne@17: ### check the version of samtools then use differnt commands jpayne@17: samtools_version=subprocess.Popen(["samtools"],stdout=subprocess.PIPE,stderr=subprocess.PIPE) jpayne@17: out, err = samtools_version.communicate() jpayne@17: version = str(err).split("ersion:")[1].strip().split(" ")[0].strip() jpayne@17: print("check samtools version:",version) jpayne@17: ### end of samtools version check and its analysis jpayne@17: if LooseVersion(version)<=LooseVersion("1.2"): jpayne@17: subprocess.check_call("samtools sort -@ "+threads+" -n "+bam+" "+fnameA+"_sorted",shell=True) jpayne@17: else: jpayne@17: subprocess.check_call("samtools sort -@ "+threads+" -n "+bam+" >"+sorted_bam,shell=True) jpayne@17: jpayne@17: def extract_mapped_reads_and_do_assembly_and_blast(current_time,sorted_bam,combined_fq,mapped_fq1,mapped_fq2,threads,fnameA,fnameB,database,mapping_mode,phred_offset): jpayne@17: #seqsero2 -a; extract, assembly and blast jpayne@17: subprocess.check_call("bamToFastq -i "+sorted_bam+" -fq "+combined_fq,shell=True) jpayne@17: #print("fnameA:",fnameA) jpayne@17: #print("fnameB:",fnameB) jpayne@17: if fnameB!="": jpayne@17: subprocess.check_call("bamToFastq -i "+sorted_bam+" -fq "+mapped_fq1+" -fq2 "+mapped_fq2 + " 2>> data_log.txt",shell=True)#2> /dev/null if want no output jpayne@17: else: jpayne@17: pass jpayne@17: outdir=current_time+"_temp" jpayne@17: print("assembling...") jpayne@17: if int(threads)>4: jpayne@17: t="4" jpayne@17: else: jpayne@17: t=threads jpayne@17: if os.path.getsize(combined_fq)>100 and (fnameB=="" or os.path.getsize(mapped_fq1)>100):#if not, then it's "-:-:-" jpayne@17: if phred_offset == 'auto': jpayne@17: phred_offset = '' jpayne@17: else: jpayne@17: phred_offset = '--phred-offset ' + phred_offset jpayne@17: jpayne@17: if fnameB!="": jpayne@17: #print("spades.py --careful "+phred_offset+" --pe1-s "+combined_fq+" --pe1-1 "+mapped_fq1+" --pe1-2 "+mapped_fq2+" -t "+t+" -o "+outdir+ " >> data_log.txt 2>&1") jpayne@17: subprocess.check_call("spades.py --careful "+phred_offset+" --pe1-s "+combined_fq+" --pe1-1 "+mapped_fq1+" --pe1-2 "+mapped_fq2+" -t "+t+" -o "+outdir+ " >> data_log.txt 2>&1",shell=True) jpayne@17: else: jpayne@17: subprocess.check_call("spades.py --careful "+phred_offset+" --pe1-s "+combined_fq+" -t "+t+" -o "+outdir+ " >> data_log.txt 2>&1",shell=True) jpayne@17: new_fasta=fnameA+"_"+database+"_"+mapping_mode+".fasta" jpayne@17: #new_fasta=fnameA+"_"+database.split('/')[-1]+"_"+mapping_mode+".fasta" # change path to databse for packaging jpayne@17: subprocess.check_call("mv "+outdir+"/contigs.fasta "+new_fasta+ " 2> /dev/null",shell=True) jpayne@17: #os.system("mv "+outdir+"/scaffolds.fasta "+new_fasta+ " 2> /dev/null") contigs.fasta jpayne@17: subprocess.check_call("rm -rf "+outdir+ " 2> /dev/null",shell=True) jpayne@17: print("blasting...","\n") jpayne@17: xmlfile="blasted_output.xml"#fnameA+"-extracted_vs_"+database+"_"+mapping_mode+".xml" jpayne@17: subprocess.check_call('makeblastdb -in '+new_fasta+' -out '+new_fasta+'_db '+'-dbtype nucl >> data_log.txt 2>&1',shell=True) #temp.txt is to forbid the blast result interrupt the output of our program###1/27/2015 jpayne@17: subprocess.check_call("blastn -query "+database+" -db "+new_fasta+"_db -out "+xmlfile+" -outfmt 5 >> data_log.txt 2>&1",shell=True)###1/27/2015; 08272018, remove "-word_size 10" jpayne@17: else: jpayne@17: xmlfile="NA" jpayne@17: return xmlfile,new_fasta jpayne@17: jpayne@17: def judge_subspecies(fnameA): jpayne@17: #seqsero2 -a; judge subspecies on just forward raw reads fastq jpayne@17: salmID_output=subprocess.Popen("SalmID.py -i "+fnameA,shell=True,stdout=subprocess.PIPE,stderr=subprocess.PIPE) jpayne@17: out, err = salmID_output.communicate() jpayne@17: out=out.decode("utf-8") jpayne@17: file=open("data_log.txt","a") jpayne@17: file.write(out) jpayne@17: file.close() jpayne@17: salm_species_scores=out.split("\n")[1].split("\t")[6:] jpayne@17: salm_species_results=out.split("\n")[0].split("\t")[6:] jpayne@17: max_score=0 jpayne@17: max_score_index=1 #default is 1, means "I" jpayne@17: for i in range(len(salm_species_scores)): jpayne@17: if max_score float(out.split("\n")[1].split("\t")[5]): #bongori and enterica compare jpayne@17: if float(out.split("\n")[1].split("\t")[4]) > 10 and float(out.split("\n")[1].split("\t")[4]) > float(out.split("\n")[1].split("\t")[5]): ## ed_SL_0318: change SalmID_ssp_threshold jpayne@17: prediction="bongori" #if not, the prediction would always be enterica, since they are located in the later part jpayne@17: #if max_score<10: ## ed_SL_0318: change SalmID_ssp_threshold jpayne@17: if max_score<60: jpayne@17: prediction="-" jpayne@17: ## ed_SL_0818: add for enterica jpayne@17: if float(out.split("\n")[1].split("\t")[5]) > 10 and float(out.split("\n")[1].split("\t")[5]) > float(out.split("\n")[1].split("\t")[4]): jpayne@17: prediction="enterica" jpayne@17: ## jpayne@17: return prediction jpayne@17: jpayne@17: def judge_subspecies_Kmer(Special_dict): jpayne@17: #seqsero2 -k; jpayne@17: max_score=0 jpayne@17: prediction="-" #default should be I jpayne@17: for x in Special_dict: jpayne@17: #if "mer" in x: ## ed_SL_0318: change ssp_threshold jpayne@17: if "mer" in x and float(Special_dict[x]) > 60: jpayne@17: if max_score95:#if bongori already, then no need to test enterica jpayne@17: prediction="bongori" jpayne@17: break jpayne@17: return prediction jpayne@17: jpayne@17: ## ed_SL_11232019: add notes for missing antigen jpayne@17: def check_antigens(ssp,O_antigen,H1_antigen,H2_antigen,NA_note): jpayne@17: antigen_note = '' jpayne@17: if ssp != '-': jpayne@17: if O_antigen != '-' and H1_antigen == '-' and H2_antigen == '-': # O:-:- jpayne@17: antigen_note = 'H antigens were not detected. This is an atypical result that should be further investigated. Most Salmonella strains have at least fliC, encoding the Phase 1 H antigen, even if it is not expressed. ' jpayne@17: NA_note = '' jpayne@17: elif O_antigen != '-' and H1_antigen == '-' and H2_antigen != '-': # O:-:H2 jpayne@17: antigen_note = 'fliC was not detected. This is an atypical result that should be further investigated. Most Salmonella strains have fliC, encoding the Phase 1 H antigen, even if it is not expressed. ' jpayne@17: NA_note = '' jpayne@17: elif O_antigen == '-' and H1_antigen != '-': # -:H1:X jpayne@17: antigen_note = 'O antigen was not detected. This result may be due to a rough strain that has deleted the rfb region. For raw reads input, the k-mer workflow is sometimes more sensitive than the microassembly workflow in detecting O antigen. Caution should be used with this approach because the k-mer result may be due to low levels of contamination. ' jpayne@17: NA_note = '' jpayne@17: elif O_antigen == '-' and H1_antigen == '-' and H2_antigen == '-': # -:-:- jpayne@17: antigen_note = 'No serotype antigens were detected. This is an atypical result that should be further investigated. ' jpayne@17: NA_note = '' jpayne@17: else: jpayne@17: antigen_note = 'The input genome cannot be identified as Salmonella. Check the input for taxonomic ID, contamination, or sequencing quality. ' jpayne@17: NA_note = '' jpayne@17: if ssp == 'enterica': jpayne@17: antigen_note += 'Subspecies identification of the input genome cannot be definitively determined. ' jpayne@17: NA_note = '' jpayne@17: # if [O_antigen, H1_antigen, H2_antigen].count('-') >= 2: jpayne@17: # antigen_note = 'No subspecies marker was detected and less than 2 serotype antigens were detected; further, this genome was not identified as Salmonella. This is an atypical result that should be further investigated. ' jpayne@17: # else: jpayne@17: # antigen_note = 'No subspecies marker was detected. This genome may not be Salmonella. This is an atypical result that should be further investigated. ' jpayne@17: return (antigen_note,NA_note) jpayne@17: jpayne@17: ## ed_SL_06062020: rename subspecies ID jpayne@17: subspecies_ID_dir = {'I': 'Salmonella enterica subspecies enterica (subspecies I)', jpayne@17: 'II': 'Salmonella enterica subspecies salamae (subspecies II)', jpayne@17: 'IIIa': 'Salmonella enterica subspecies arizonae (subspecies IIIa)', jpayne@17: 'IIIb': 'Salmonella enterica subspecies diarizonae (subspecies IIIb)', jpayne@17: 'IV': 'Salmonella enterica subspecies houtenae (subspecies IV)', jpayne@17: 'VI': 'Salmonella enterica subspecies indica (subspecies VI)', jpayne@17: 'VII': 'Salmonella enterica subspecies VII (subspecies VII)', jpayne@17: 'bongori': 'Salmonella bongori', jpayne@17: 'enterica': 'Salmonella enterica', jpayne@17: '-': '-'} jpayne@17: ## jpayne@17: jpayne@17: ## ed_SL_08172020: format check for fasta or fastq in nanopore workflow, convert raw reads fastq to fasta jpayne@17: def format_check(input_file): jpayne@17: line=open(input_file,'r').readline() jpayne@17: if line.startswith('>'): jpayne@17: output_file = input_file jpayne@17: elif line.startswith('@'): jpayne@17: input_file_fa = input_file + '.fasta' jpayne@17: subprocess.check_call("seqtk seq -A "+input_file+" > "+input_file_fa,shell=True) jpayne@17: output_file = input_file_fa jpayne@17: else: jpayne@17: print ('please check the format of input files') jpayne@17: return (output_file) jpayne@17: ## jpayne@17: jpayne@17: def main(): jpayne@17: #combine SeqSeroK and SeqSero2, also with SalmID jpayne@17: args = parse_args() jpayne@17: input_file = args.i jpayne@17: data_type = args.t jpayne@17: analysis_mode = args.m jpayne@17: mapping_mode=args.b jpayne@17: threads=args.p jpayne@17: make_dir=args.d jpayne@17: clean_mode=args.c jpayne@17: sample_name=args.n jpayne@17: ingore_header=args.s jpayne@17: phred_offset=args.phred_offset jpayne@17: k_size=27 #will change for bug fixing jpayne@17: dirpath = os.path.abspath(os.path.dirname(os.path.realpath(__file__))) jpayne@17: ex_dir = os.path.abspath(os.path.join(os.path.dirname(os.path.dirname(__file__)),'seqsero2_db')) # ed_SL_09152019: add ex_dir for packaging jpayne@17: seqsero2_db=ex_dir+"/H_and_O_and_specific_genes.fasta" # ed_SL_11092019: change path to database for packaging jpayne@17: database="H_and_O_and_specific_genes.fasta" jpayne@17: note="Note: " jpayne@17: NA_note="This predicted serotype is not in the Kauffman-White scheme. " # ed_SL_09272019: add for new output format jpayne@17: if len(sys.argv)==1: jpayne@17: subprocess.check_call(dirpath+"/SeqSero2_package.py -h",shell=True)#change name of python file jpayne@17: else: jpayne@17: request_id = time.strftime("%m_%d_%Y_%H_%M_%S", time.localtime()) jpayne@17: request_id += str(random.randint(1, 10000000)) jpayne@17: if make_dir is None: jpayne@17: make_dir="SeqSero_result_"+request_id jpayne@17: make_dir=os.path.abspath(make_dir) jpayne@17: if os.path.isdir(make_dir): jpayne@17: pass jpayne@17: else: jpayne@17: subprocess.check_call("mkdir -p "+make_dir,shell=True) jpayne@17: #subprocess.check_call("cp "+dirpath+"/"+database+" "+" ".join(input_file)+" "+make_dir,shell=True) jpayne@17: #subprocess.check_call("ln -sr "+dirpath+"/"+database+" "+" ".join(input_file)+" "+make_dir,shell=True) jpayne@17: subprocess.check_call("ln -f -s "+seqsero2_db+" "+" ".join(input_file)+" "+make_dir,shell=True) # ed_SL_11092019: change path to database for packaging jpayne@17: #subprocess.check_call("ln -f -s "+dirpath+"/"+database+" "+" ".join(input_file)+" "+make_dir,shell=True) ### use -f option to force the replacement of links, remove -r and use absolute path instead to avoid link issue (use 'type=os.path.abspath' in -i argument). jpayne@17: ############################begin the real analysis jpayne@17: if analysis_mode=="a": jpayne@17: if data_type in ["1","2","3"]:#use allele mode jpayne@17: for_fq,rev_fq=get_input_files(make_dir,input_file,data_type,dirpath) jpayne@17: os.chdir(make_dir) jpayne@17: ###add a function to tell input files jpayne@17: fnameA=for_fq.split("/")[-1] jpayne@17: fnameB=rev_fq.split("/")[-1] jpayne@17: current_time=time.strftime("%Y_%m_%d_%H_%M_%S", time.localtime()) jpayne@17: sam,bam,sorted_bam,mapped_fq1,mapped_fq2,combined_fq,for_sai,rev_sai=get_temp_file_names(fnameA,fnameB) #get temp files id jpayne@17: map_and_sort(threads,database,fnameA,fnameB,sam,bam,for_sai,rev_sai,sorted_bam,mapping_mode) #do mapping and sort jpayne@17: jpayne@17: ### avoid error out when micro assembly fails. ed_SL_03172020 jpayne@17: try: jpayne@17: xmlfile,new_fasta=extract_mapped_reads_and_do_assembly_and_blast(current_time,sorted_bam,combined_fq,mapped_fq1,mapped_fq2,threads,fnameA,fnameB,database,mapping_mode,phred_offset) #extract the mapped reads and do micro assembly and blast jpayne@17: except (UnboundLocalError, subprocess.CalledProcessError): jpayne@17: xmlfile="NA" jpayne@17: H1_cont_stat_list=[] jpayne@17: H2_cont_stat_list=[] jpayne@17: ### jpayne@17: if xmlfile=="NA": jpayne@17: O_choice,fliC_choice,fljB_choice,special_gene_list,contamination_O,contamination_H=("-","-","-",[],"","") jpayne@17: else: jpayne@17: Final_list=xml_parse_score_comparision_seqsero(xmlfile) #analyze xml and get parsed results jpayne@17: file=open("data_log.txt","a") jpayne@17: for x in Final_list: jpayne@17: file.write("\t".join(str(y) for y in x)+"\n") jpayne@17: file.close() jpayne@17: Final_list_passed=[x for x in Final_list if float(x[0].split("_cov_")[1].split("_")[0])>=0.9 and (x[1]>=int(x[0].split("__")[1]) or x[1]>=int(x[0].split("___")[1].split("_")[3]) or x[1]>1000)] jpayne@17: O_choice,fliC_choice,fljB_choice,special_gene_list,contamination_O,contamination_H,Otypes_uniq,H1_cont_stat_list,H2_cont_stat_list=predict_O_and_H_types(Final_list,Final_list_passed,new_fasta) #predict O, fliC and fljB jpayne@17: subspecies=judge_subspecies(fnameA) #predict subspecies jpayne@17: ### ed_SL_06062020: correction VIII -> II jpayne@17: if subspecies == 'VIII': jpayne@17: subspecies = 'II' jpayne@17: ### ed_SL_08132020: correction VII -> IV, according to CDC's suggestion jpayne@17: if subspecies == 'VII': jpayne@17: subspecies = 'IV' jpayne@17: note+='SalmID reports this as ssp VII, which has not been formally recognized. ' jpayne@17: ### jpayne@17: ### ed_SL_08182020: change serotype ouput for genome without definitive subspecies ID jpayne@17: ssp_pointer = subspecies jpayne@17: if subspecies == 'enterica': jpayne@17: subspecies = '-' jpayne@17: ### jpayne@17: ###output jpayne@17: predict_form,predict_sero,star,star_line,claim=seqsero_from_formula_to_serotypes(O_choice,fliC_choice,fljB_choice,special_gene_list,subspecies) jpayne@17: claim="" #04132019, disable claim for new report requirement jpayne@17: contamination_report="" jpayne@17: H_list=["fliC_"+x for x in H1_cont_stat_list if len(x)>0]+["fljB_"+x for x in H2_cont_stat_list if len(x)>0] jpayne@17: if contamination_O!="" and contamination_H=="": jpayne@17: contamination_report="#Potential inter-serotype contamination detected from O antigen signals. All O-antigens detected:"+"\t".join(Otypes_uniq)+"." jpayne@17: elif contamination_O=="" and contamination_H!="": jpayne@17: contamination_report="#Potential inter-serotype contamination detected or potential thrid H phase from H antigen signals. All H-antigens detected:"+"\t".join(H_list)+"." jpayne@17: elif contamination_O!="" and contamination_H!="": jpayne@17: contamination_report="#Potential inter-serotype contamination detected from both O and H antigen signals.All O-antigens detected:"+"\t".join(Otypes_uniq)+". All H-antigens detected:"+"\t".join(H_list)+"." jpayne@17: if contamination_report!="": jpayne@17: #contamination_report="potential inter-serotype contamination detected (please refer below antigen signal report for details)." #above contamination_reports are for back-up and bug fixing #web-based mode need to be re-used, 04132019 jpayne@17: contamination_report="Co-existence of multiple serotypes detected, indicating potential inter-serotype contamination. See 'Extracted_antigen_alleles.fasta' for detected serotype determinant alleles. " jpayne@17: #claim="\n"+open("Extracted_antigen_alleles.fasta","r").read()#used to store H and O antigen sequeences #04132019, need to change if using web-version jpayne@17: #if contamination_report+star_line+claim=="": #0413, new output style jpayne@17: # note="" jpayne@17: #else: jpayne@17: # note="Note:" jpayne@17: jpayne@17: ### ed_SL_11232019: add notes for missing antigen jpayne@17: if O_choice=="": jpayne@17: O_choice="-" jpayne@17: antigen_note,NA_note=check_antigens(ssp_pointer,O_choice,fliC_choice,fljB_choice,NA_note) jpayne@17: if sample_name: jpayne@17: print ("Sample name:\t"+sample_name) jpayne@17: ### jpayne@17: if clean_mode: jpayne@17: subprocess.check_call("rm -rf "+make_dir,shell=True) jpayne@17: make_dir="none-output-directory due to '-c' flag" jpayne@17: else: jpayne@17: new_file=open("SeqSero_result.txt","w") jpayne@17: ### ed_SL_01152020: add new output jpayne@17: conta_note="yes" if "inter-serotype contamination" in contamination_report else "no" jpayne@17: tsv_file=open("SeqSero_result.tsv","w") jpayne@17: if ingore_header: jpayne@17: pass jpayne@17: else: jpayne@17: tsv_file.write("Sample name\tOutput directory\tInput files\tO antigen prediction\tH1 antigen prediction(fliC)\tH2 antigen prediction(fljB)\tPredicted identification\tPredicted antigenic profile\tPredicted serotype\tPotential inter-serotype contamination\tNote\n") jpayne@17: if sample_name: jpayne@17: new_file.write("Sample name:\t"+sample_name+"\n") jpayne@17: tsv_file.write(sample_name+'\t') jpayne@17: else: jpayne@17: tsv_file.write(input_file[0].split('/')[-1]+'\t') jpayne@17: ### jpayne@17: if "N/A" not in predict_sero: jpayne@17: new_file.write("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+"\t".join(input_file)+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+fliC_choice+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+fljB_choice+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+predict_sero+"\n"+ jpayne@17: note+contamination_report+star_line+claim+antigen_note+"\n")#+## jpayne@17: tsv_file.write(make_dir+"\t"+" ".join(input_file)+"\t"+O_choice+"\t"+fliC_choice+"\t"+fljB_choice+"\t"+subspecies_ID_dir[ssp_pointer]+"\t"+predict_form+"\t"+predict_sero+"\t"+conta_note+"\t"+contamination_report+star_line+claim+antigen_note+"\n") jpayne@17: else: jpayne@17: #star_line=star_line.strip()+"\tNone such antigenic formula in KW.\n" jpayne@17: #star_line="" #04132019, for new output requirement, diable star_line if "NA" in output jpayne@17: new_file.write("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+"\t".join(input_file)+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+fliC_choice+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+fljB_choice+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+subspecies+' '+predict_form+"\n"+ # add serotype output for "N/A" prediction, add subspecies jpayne@17: note+NA_note+contamination_report+star_line+claim+antigen_note+"\n")#+## jpayne@17: tsv_file.write(make_dir+"\t"+" ".join(input_file)+"\t"+O_choice+"\t"+fliC_choice+"\t"+fljB_choice+"\t"+subspecies_ID_dir[ssp_pointer]+"\t"+predict_form+"\t"+subspecies+' '+predict_form+"\t"+conta_note+"\t"+NA_note+contamination_report+star_line+claim+antigen_note+"\n") jpayne@17: new_file.close() jpayne@17: tsv_file.close() jpayne@17: #subprocess.check_call("cat Seqsero_result.txt",shell=True) jpayne@17: #subprocess.call("rm H_and_O_and_specific_genes.fasta* *.sra *.bam *.sam *.fastq *.gz *.fq temp.txt *.xml "+fnameA+"*_db* 2> /dev/null",shell=True) jpayne@17: subprocess.call("rm H_and_O_and_specific_genes.fasta* *.sra *.bam *.sam *.fastq *.gz *.fq temp.txt "+fnameA+"*_db* 2> /dev/null",shell=True) jpayne@17: if "N/A" not in predict_sero: jpayne@17: #print("Output_directory:"+make_dir+"\nInput files:\t"+for_fq+" "+rev_fq+"\n"+"O antigen prediction:\t"+O_choice+"\n"+"H1 antigen prediction(fliC):\t"+fliC_choice+"\n"+"H2 antigen prediction(fljB):\t"+fljB_choice+"\n"+"Predicted antigenic profile:\t"+predict_form+"\n"+"Predicted subspecies:\t"+subspecies+"\n"+"Predicted serotype(s):\t"+predict_sero+star+"\nNote:"+contamination_report+star+star_line+claim+"\n")#+## jpayne@17: print("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+"\t".join(input_file)+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+fliC_choice+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+fljB_choice+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+predict_sero+"\n"+ jpayne@17: note+contamination_report+star_line+claim+antigen_note+"\n")#+## jpayne@17: else: jpayne@17: print("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+"\t".join(input_file)+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+fliC_choice+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+fljB_choice+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+subspecies+' '+predict_form+"\n"+ # add serotype output for "N/A" prediction, subspecies jpayne@17: note+NA_note+contamination_report+star_line+claim+antigen_note+"\n") jpayne@17: else: jpayne@17: print("Allele modes only support raw reads datatype, i.e. '-t 1 or 2 or 3'; please use '-m k'") jpayne@17: elif analysis_mode=="k": jpayne@17: #ex_dir = os.path.dirname(os.path.realpath(__file__)) jpayne@17: ex_dir = os.path.abspath(os.path.join(os.path.dirname(os.path.dirname(__file__)),'seqsero2_db')) # ed_SL_09152019: change ex_dir for packaging jpayne@17: #output_mode = args.mode jpayne@17: for_fq,rev_fq=get_input_files(make_dir,input_file,data_type,dirpath) jpayne@17: input_file = for_fq #-k will just use forward because not all reads were used jpayne@17: os.chdir(make_dir) jpayne@17: ### ed_SL_08182020: use assembly workflow for nanopore fastq, convert fastq to fasta jpayne@17: if data_type == "5": jpayne@17: input_file = format_check(for_fq) jpayne@17: ### jpayne@17: f = open(ex_dir + '/antigens.pickle', 'rb') jpayne@17: lib_dict = pickle.load(f) jpayne@17: f.close jpayne@17: input_Ks=get_input_K(input_file,lib_dict,data_type,k_size) jpayne@17: O_dict,H_dict,Special_dict=get_kmer_dict(lib_dict,input_Ks) jpayne@17: highest_O,highest_fliC,highest_fljB=call_O_and_H_type(O_dict,H_dict,Special_dict,make_dir) jpayne@17: subspecies=judge_subspecies_Kmer(Special_dict) jpayne@17: if subspecies=="IIb" or subspecies=="IIa": jpayne@17: subspecies="II" jpayne@17: ### ed_SL_06062020: correction VIII -> II jpayne@17: if subspecies == 'VIII': jpayne@17: subspecies = 'II' jpayne@17: ### ed_SL_08132020: correction VII -> IV, according to CDC's suggestion jpayne@17: if subspecies == 'VII': jpayne@17: subspecies = 'IV' jpayne@17: note+='SalmID reports this as ssp VII, which has not been formally recognized. ' jpayne@17: ### jpayne@17: ### ed_SL_08182020: change serotype ouput for genome without definitive subspecies ID jpayne@17: ssp_pointer = subspecies jpayne@17: if subspecies == 'enterica': jpayne@17: subspecies = '-' jpayne@17: ### jpayne@17: predict_form,predict_sero,star,star_line,claim = seqsero_from_formula_to_serotypes( jpayne@17: highest_O.split('-')[1], highest_fliC, highest_fljB, Special_dict,subspecies) jpayne@17: claim="" #no claim any more based on new output requirement jpayne@17: #if star_line+claim=="": #0413, new output style jpayne@17: # note="" jpayne@17: #else: jpayne@17: # note="Note:" jpayne@17: jpayne@17: ### ed_SL_11232019: add notes for missing antigen jpayne@17: if highest_O.split('-')[-1]=="": jpayne@17: O_choice="-" jpayne@17: else: jpayne@17: O_choice=highest_O.split('-')[-1] jpayne@17: antigen_note,NA_note=check_antigens(ssp_pointer,O_choice,highest_fliC,highest_fljB,NA_note) jpayne@17: if sample_name: jpayne@17: print ("Sample name:\t"+sample_name) jpayne@17: ### jpayne@17: jpayne@17: if clean_mode: jpayne@17: subprocess.check_call("rm -rf "+make_dir,shell=True) jpayne@17: make_dir="none-output-directory due to '-c' flag" jpayne@17: else: jpayne@17: new_file=open("SeqSero_result.txt","w") jpayne@17: tsv_file=open("SeqSero_result.tsv","w") jpayne@17: # ### ed_SL_05282019, fix the assignment issue of variable 'O_choice' using "-m k -c" jpayne@17: # if highest_O.split('-')[-1]=="": jpayne@17: # O_choice="-" jpayne@17: # else: jpayne@17: # O_choice=highest_O.split('-')[-1] jpayne@17: # ### jpayne@17: # else: jpayne@17: # if highest_O.split('-')[-1]=="": jpayne@17: # O_choice="-" jpayne@17: # else: jpayne@17: # O_choice=highest_O.split('-')[-1] jpayne@17: #print("Output_directory:"+make_dir+"\tInput_file:"+input_file+"\tPredicted subpecies:"+subspecies + '\tPredicted antigenic profile:' + predict_form + '\tPredicted serotype(s):' + predict_sero) jpayne@17: # new_file=open("SeqSero_result.txt","w") jpayne@17: #new_file.write("Output_directory:"+make_dir+"\nInput files:\t"+input_file+"\n"+"O antigen prediction:\t"+O_choice+"\n"+"H1 antigen prediction(fliC):\t"+highest_fliC+"\n"+"H2 antigen prediction(fljB):\t"+highest_fljB+"\n"+"Predicted antigenic profile:\t"+predict_form+"\n"+"Predicted subspecies:\t"+subspecies+"\n"+"Predicted serotype(s):\t"+predict_sero+star+"\n"+star+star_line+claim+"\n")#+## jpayne@17: ### ed_SL_01152020: add new output jpayne@17: # tsv_file=open("SeqSero_result.tsv","w") jpayne@17: if ingore_header: jpayne@17: pass jpayne@17: else: jpayne@17: tsv_file.write("Sample name\tOutput directory\tInput files\tO antigen prediction\tH1 antigen prediction(fliC)\tH2 antigen prediction(fljB)\tPredicted identification\tPredicted antigenic profile\tPredicted serotype\tNote\n") jpayne@17: if sample_name: jpayne@17: new_file.write("Sample name:\t"+sample_name+"\n") jpayne@17: tsv_file.write(sample_name+'\t') jpayne@17: else: jpayne@17: tsv_file.write(input_file.split('/')[-1]+'\t') jpayne@17: ### jpayne@17: if "N/A" not in predict_sero: jpayne@17: new_file.write("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+input_file+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+highest_fliC+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+highest_fljB+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+predict_sero+"\n"+ jpayne@17: note+star_line+claim+antigen_note+"\n")#+## jpayne@17: tsv_file.write(make_dir+"\t"+input_file+"\t"+O_choice+"\t"+highest_fliC+"\t"+highest_fljB+"\t"+subspecies_ID_dir[ssp_pointer]+"\t"+predict_form+"\t"+predict_sero+"\t"+star_line+claim+antigen_note+"\n") jpayne@17: else: jpayne@17: #star_line=star_line.strip()+"\tNone such antigenic formula in KW.\n" jpayne@17: #star_line = "" #changed for new output requirement, 04132019 jpayne@17: new_file.write("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+input_file+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+highest_fliC+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+highest_fljB+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+subspecies+' '+predict_form+"\n"+ # add serotype output for "N/A" prediction, subspecies jpayne@17: note+NA_note+star_line+claim+antigen_note+"\n")#+## jpayne@17: tsv_file.write(make_dir+"\t"+input_file+"\t"+O_choice+"\t"+highest_fliC+"\t"+highest_fljB+"\t"+subspecies_ID_dir[ssp_pointer]+"\t"+predict_form+"\t"+subspecies+' '+predict_form+"\t"+NA_note+star_line+claim+antigen_note+"\n") jpayne@17: new_file.close() jpayne@17: tsv_file.close() jpayne@17: subprocess.call("rm *.fasta* *.fastq *.gz *.fq temp.txt *.sra 2> /dev/null",shell=True) jpayne@17: if "N/A" not in predict_sero: jpayne@17: print("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+input_file+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+highest_fliC+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+highest_fljB+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+predict_sero+"\n"+ jpayne@17: note+star_line+claim+antigen_note+"\n")#+## jpayne@17: else: jpayne@17: print("Output directory:\t"+make_dir+"\n"+ jpayne@17: "Input files:\t"+input_file+"\n"+ jpayne@17: "O antigen prediction:\t"+O_choice+"\n"+ jpayne@17: "H1 antigen prediction(fliC):\t"+highest_fliC+"\n"+ jpayne@17: "H2 antigen prediction(fljB):\t"+highest_fljB+"\n"+ jpayne@17: "Predicted identification:\t"+subspecies_ID_dir[ssp_pointer]+"\n"+ jpayne@17: "Predicted antigenic profile:\t"+predict_form+"\n"+ jpayne@17: "Predicted serotype:\t"+subspecies+' '+predict_form+"\n"+ # add serotype output for "N/A" prediction, subspecies jpayne@17: note+NA_note+star_line+claim+antigen_note+"\n")#+## jpayne@17: jpayne@17: if __name__ == '__main__': jpayne@17: main()