1 TODO

  • Remove MSstats logging. – done
  • Make explicit spearman correlations between methods. – done
    • Do both for all data and for the top-50/bottom-50 – done, but weird.
  • Make 100% certain that the samples are annotated correctly. – done.
  • Limma/MSstats/EdgeR venn disagram for all up in CF
    • Repeat in all down CF
    • Repeat with a cutoff, top-50
  • Individual plots for P/PE proteins.

2 Analyzing data from openMS and friends.

In preprocessing_comet_highres.Rmd, I used the openMS tutorials and supplemental materials from a couple papers to hopefully correctly perform the various preprocessing tasks required to extract intensity data from DIA/SWATH transitions.

The final steps of that process combined the transition intensities from every sample into a metadata frile (results/tric/HCD_meta.tsv), an intensity matrix (results/tric/HCD_outmatrix.tsv), and a feature aligned output matrix (results/tric/aligned_comet_HCD.tsv).

My reading of the SWATH2stats and MSstats source code suggests to me that the log2(intensities) of the feature aligned data are our final proxy for protein abundance. At first glance, this suggests to me that these data might follow a distribution similar to RNASeq data (negative binomial, but perhaps with a bigger tail?). In addition, by the time we use tric on the data, we have a count matrix and sample annotation data frames which look remarkably similar to those used in a RNASeq expressionset. Indeed, by the end of the MSstats processing, it creates a MSnSet class of its own which uses fData/exprs/pData.

For the curious, my reasoning for saying that the log intensities are our proxy for abundance comes from MSstats/R/DataProcess.R in a clause which looks like:

if (logTrans == 2) {
  work[["ABUNDANCE"]] <- log2(work[["ABUNDANCE"]])
} else if (logTrans == 10) {
  work[["ABUNDANCE"]] <- log10(work[["ABUNDANCE"]])
} else {
  ## Above there was a check for only log 2 and 10, but we can do e if we want.
  ## I might go back up there and remove that check. Long live e! 2.718282 rules!
  work[["ABUNDANCE"]] <- log(work[["ABUNDANCE"]]) / log(logTrans)
}

(Note: I added the natural log to the set of conditions, but otherwise the logic is unchanged.)

With that in mind, I want to use some tools with which I am familiar in order to try to understand these data. Therefore I will first attempt to coerce my tric aligned data and annotations into a ‘normal’ expressionset. Then I want to do some diagnostic plots which, if I am wrong and these distributions are not as expected, will be conceptually incorrect (I don’t yet think I am wrong).

2.1 Sample annotation via SWATH2stats

I am using the SWATH2stats vignette as my primary source of information. Thus I see that it uses the OpenSWATH_SM3_GoldStandardAutomatedResults_human_peakgroups.txt which has a format nearly identical to my tric output matrix. Thus for the moment I will assume that the proper input for SWATH2stats is ‘results/tric/comet_HCD.tsv’ and not the metadata nor output matrix.

I keep a sample sheet of all the DIA samples used in this analysis in ‘sample_sheets/dia_samples.xlsx’ It should contain all the other required data with one important caveat, I removed 1 sample by ‘commenting’ it (e.g. prefixing it with ‘##’ – which is an admittedly dumb thing to do in an excel file.

One last caveat: I hacked the SWATH2stats sample_annotation() function to add a couple columns in an attempt to make it a little more robust when faced with sample sheets with differently named columns.

In addition, SWATH2stats provides some nice filtering and combination functions which should be considered when generating various expressionset data structures later.

tric_data <- read.csv("results/tric_201805/comet_HCD.tsv", sep="\t")

sample_annot <- openxlsx::read.xlsx("sample_sheets/Mtb_dia_samples.xlsx")
rownames(sample_annot) <- make.names(sample_annot[["sampleid"]], unique=TRUE)
## Drop samples starting with comments
keep_idx <- ! grepl(pattern="##", x=rownames(sample_annot))
sample_annot <- sample_annot[keep_idx, ]
expt_idx <- sample_annot[["expt_id"]] == "may2018"
expt_idx[is.na(sample_annot[["expt_id"]])] <- FALSE
sample_annot <- sample_annot[expt_idx, ]
## Set the mzXML column to match the filename column in the data.
devtools::load_all("~/scratch/git/SWATH2stats")
## Loading SWATH2stats
## s2s, my witty way of shortening SWATH2stats...
s2s_exp <- sample_annotation(data=tric_data,
                             sample_annotation=sample_annot,
                             fullpeptidename_column="fullunimodpeptidename")

############
## IMPORTANT CAVEAT
############
## HEY YOU, TREY, READ THIS OR YOU WILL BE PISSED LATER
############
## I am keeping only those rows which are from the march run.
dim(s2s_exp)
## [1] 87153    33
## Wow, that dropped 46% of the data

Now I have a couple data structures which should prove useful for the metrics provided by SWATH2stats, MSstats, and my own hpgltools.

3 SWATH2stats continued

Lets return to some of the metrics provided by swath2stats.

## Get correlations on a sample by sample basis
pp(file="images/swath2stats_sample_cor.png")
## Going to write the image to: images/swath2stats_sample_cor.png when dev.off() is called.
sample_cor <- plot_correlation_between_samples(s2s_exp,
                                               Comparison=transition_group_id ~ run,
                                               fun.aggregate=sum,
                                               column.values="intensity")
dev.off()
## png 
##   2
sample_cond_rep_cor <- plot_correlation_between_samples(s2s_exp,
                                                        Comparison=transition_group_id ~
                                                          condition + bioreplicate + run,
                                                        fun.aggregate=sum,
                                                        column.values="intensity")

## I am a little concerned that these values do not seem to change when I took
## filtered/normalized data.  So I am rerunning them manually for a moment --
## perhaps I messed something up when I rewrote portions of the
## sample_annotation() function in SWATH2stats.

## ahh I think I see the problem.  The default value for fun.aggregate is NULL,
## which causes dcast to default to length.  I think this is not likely to be
## valid for this data.  I am not certain, however, what is the appropriate
## function.  If I had to guess, I would go with sum()?

assess_decoy_rate(s2s_exp)
## Number of non-decoy peptides: 16134
## Number of decoy peptides: 0
## Decoy rate: 0.0000
## This seems a bit high to me, yesno?
fdr_overall <- assess_fdr_overall(s2s_exp, output="Rconsole", plot=TRUE)

byrun_fdr <- assess_fdr_byrun(s2s_exp, FFT=0.7, plot=TRUE, output="Rconsole")
## The average FDR by run on assay level is 0
## The average FDR by run on peptide level is 0
## The average FDR by run on protein level is 0

mscore4assayfdr(s2s_exp, FFT=0.7, fdr_target=0.02)
## Target assay FDR: 0.02
## Required overall m-score cutoff:0.01
## achieving assay FDR =0
## [1] 0.01
prot_score <- mscore4protfdr(s2s_exp, FFT=0.7, fdr_target=0.02)
## Target protein FDR:0.02
## Required overall m-score cutoff:NA
## achieving protein FDR =NA
mscore_filtered <- SWATH2stats::filter_mscore(s2s_exp, prot_score)
## Dimension difference: 0, 0
data_filtered_mscore <- filter_mscore_freqobs(s2s_exp, 0.01, 0.8, rm.decoy=FALSE)
## Error in `$<-.data.frame`(`*tmp*`, Peptide_Charge, value = character(0)): replacement has 0 rows, data has 87153
data_filtered_fdr <- filter_mscore_fdr(s2s_exp, FFT=0.7,
                                       overall_protein_fdr_target=0.03,
                                       upper_overall_peptide_fdr_limit=0.05)
## Target protein FDR:0.03
## 
## Required overall m-score cutoff:NA
## achieving protein FDR =NA
## Error in filter_mscore_fdr(s2s_exp, FFT = 0.7, overall_protein_fdr_target = 0.03, : The overall_protein_fdr_target cannot be reached in this dataset. 
## 
##          Consider using a higher accepted FDR criterion. 
## 
##          Check mProphet models for target-decoy separation.
only_proteotypic <- filter_proteotypic_peptides(data_filtered_fdr)
## Error in unifyProteinGroupLabels(data): object 'data_filtered_fdr' not found
all_filtered <- filter_all_peptides(data_filtered_fdr)
## Error in gsub("^[[:digit:]]\\/", "", data$ProteinName): object 'data_filtered_fdr' not found
only_strong <- filter_on_max_peptides(data_filtered_fdr, 5)
## Error in unifyProteinGroupLabels(data): object 'data_filtered_fdr' not found
only_minimum <- filter_on_min_peptides(only_strong, 2)
## Error in unifyProteinGroupLabels(data): object 'only_strong' not found
## I think these matrixes are probably smarter to use than the raw outmatrix from tric.
## But I am not a fan of rerwriting the sample column names.
protein_matrix_all <- write_matrix_proteins(s2s_exp, write.csv=TRUE,
                                            filename="swath2stats_protein_all_201805.csv")
## Protein overview matrix swath2stats_protein_all_201805.csv written to working folder.
protein_matrix_mscore <- write_matrix_proteins(mscore_filtered, write.csv=TRUE,
                                               filename="swath2stats_protein_matrix_mscore.csv",
                                               rm.decoy=FALSE)
## Error in .fun(.value[0], ...): invalid 'type' (list) of argument
dim(protein_matrix_mscore)
## Error in eval(expr, envir, enclos): object 'protein_matrix_mscore' not found
peptide_matrix_mscore <- write_matrix_peptides(mscore_filtered, write.csv=TRUE,
                                               filename="swath2stats_peptide_matrix_mscore.csv",
                                               rm.decoy=FALSE)
## Error in `[.data.frame`(data, , c("ProteinName", "run_id", "FullPeptideName", : undefined columns selected
protein_matrix_minimum <- write_matrix_proteins(only_minimum, write.csv=TRUE,
                                                filename="swath2stats_protein_matrix_minimum.csv",
                                                rm.decoy=FALSE)
## Error in aggregate(data[, "intensity"], by = list(data[["proteinname"]], : object 'only_minimum' not found
dim(protein_matrix_minimum)
## Error in eval(expr, envir, enclos): object 'protein_matrix_minimum' not found
peptide_matrix_minimum <- write_matrix_peptides(only_minimum, write.csv=TRUE,
                                                filename="swath2stats_peptide_matrix_minimum.csv",
                                                rm.decoy=FALSE)
## Error in write_matrix_peptides(only_minimum, write.csv = TRUE, filename = "swath2stats_peptide_matrix_minimum.csv", : object 'only_minimum' not found
SWATH2stats::plot_correlation_between_samples(s2s_exp,
                                              column.values="rt",
                                              fun.aggregate=sum)

##                 Var1             Var2  value   method
## 1       comp_cf_br17     comp_cf_br17 1.0000  pearson
## 13      comp_cf_br17     comp_cf_br18 0.7684  pearson
## 14      comp_cf_br18     comp_cf_br18 1.0000  pearson
## 25      comp_cf_br17     comp_cf_br19 0.7986  pearson
## 26      comp_cf_br18     comp_cf_br19 0.7875  pearson
## 27      comp_cf_br19     comp_cf_br19 1.0000  pearson
## 37      comp_cf_br17  comp_whole_br11 0.2094  pearson
## 38      comp_cf_br18  comp_whole_br11 0.1989  pearson
## 39      comp_cf_br19  comp_whole_br11 0.1990  pearson
## 40   comp_whole_br11  comp_whole_br11 1.0000  pearson
## 49      comp_cf_br17  comp_whole_br12 0.2757  pearson
## 50      comp_cf_br18  comp_whole_br12 0.2688  pearson
## 51      comp_cf_br19  comp_whole_br12 0.2817  pearson
## 52   comp_whole_br11  comp_whole_br12 0.1458  pearson
## 53   comp_whole_br12  comp_whole_br12 1.0000  pearson
## 61      comp_cf_br17  comp_whole_br13 0.2563  pearson
## 62      comp_cf_br18  comp_whole_br13 0.2499  pearson
## 63      comp_cf_br19  comp_whole_br13 0.2619  pearson
## 64   comp_whole_br11  comp_whole_br13 0.1488  pearson
## 65   comp_whole_br12  comp_whole_br13 0.6946  pearson
## 66   comp_whole_br13  comp_whole_br13 1.0000  pearson
## 73      comp_cf_br17    delta_cf_br14 0.7126  pearson
## 74      comp_cf_br18    delta_cf_br14 0.7028  pearson
## 75      comp_cf_br19    delta_cf_br14 0.7119  pearson
## 76   comp_whole_br11    delta_cf_br14 0.2252  pearson
## 77   comp_whole_br12    delta_cf_br14 0.2154  pearson
## 78   comp_whole_br13    delta_cf_br14 0.2049  pearson
## 79     delta_cf_br14    delta_cf_br14 1.0000  pearson
## 85      comp_cf_br17    delta_cf_br15 0.7834  pearson
## 86      comp_cf_br18    delta_cf_br15 0.7665  pearson
## 87      comp_cf_br19    delta_cf_br15 0.7826  pearson
## 88   comp_whole_br11    delta_cf_br15 0.2075  pearson
## 89   comp_whole_br12    delta_cf_br15 0.2500  pearson
## 90   comp_whole_br13    delta_cf_br15 0.2364  pearson
## 91     delta_cf_br14    delta_cf_br15 0.7684  pearson
## 92     delta_cf_br15    delta_cf_br15 1.0000  pearson
## 97      comp_cf_br17    delta_cf_br16 0.7983  pearson
## 98      comp_cf_br18    delta_cf_br16 0.7517  pearson
## 99      comp_cf_br19    delta_cf_br16 0.7687  pearson
## 100  comp_whole_br11    delta_cf_br16 0.2089  pearson
## 101  comp_whole_br12    delta_cf_br16 0.2492  pearson
## 102  comp_whole_br13    delta_cf_br16 0.2350  pearson
## 103    delta_cf_br14    delta_cf_br16 0.7595  pearson
## 104    delta_cf_br15    delta_cf_br16 0.8103  pearson
## 105    delta_cf_br16    delta_cf_br16 1.0000  pearson
## 109     comp_cf_br17 delta_whole_br10 0.4294  pearson
## 110     comp_cf_br18 delta_whole_br10 0.4189  pearson
## 111     comp_cf_br19 delta_whole_br10 0.4318  pearson
## 112  comp_whole_br11 delta_whole_br10 0.2289  pearson
## 113  comp_whole_br12 delta_whole_br10 0.4660  pearson
## 114  comp_whole_br13 delta_whole_br10 0.4442  pearson
## 115    delta_cf_br14 delta_whole_br10 0.3727  pearson
## 116    delta_cf_br15 delta_whole_br10 0.4018  pearson
## 117    delta_cf_br16 delta_whole_br10 0.4083  pearson
## 118 delta_whole_br10 delta_whole_br10 1.0000  pearson
## 121     comp_cf_br17  delta_whole_br8 0.2662  pearson
## 122     comp_cf_br18  delta_whole_br8 0.2607  pearson
## 123     comp_cf_br19  delta_whole_br8 0.2767  pearson
## 124  comp_whole_br11  delta_whole_br8 0.1535  pearson
## 125  comp_whole_br12  delta_whole_br8 0.6837  pearson
## 126  comp_whole_br13  delta_whole_br8 0.6873  pearson
## 127    delta_cf_br14  delta_whole_br8 0.2121  pearson
## 128    delta_cf_br15  delta_whole_br8 0.2491  pearson
## 129    delta_cf_br16  delta_whole_br8 0.2448  pearson
## 130 delta_whole_br10  delta_whole_br8 0.4518  pearson
## 131  delta_whole_br8  delta_whole_br8 1.0000  pearson
## 133     comp_cf_br17  delta_whole_br9 0.2688  pearson
## 134     comp_cf_br18  delta_whole_br9 0.2611  pearson
## 135     comp_cf_br19  delta_whole_br9 0.2765  pearson
## 136  comp_whole_br11  delta_whole_br9 0.1562  pearson
## 137  comp_whole_br12  delta_whole_br9 0.6709  pearson
## 138  comp_whole_br13  delta_whole_br9 0.6630  pearson
## 139    delta_cf_br14  delta_whole_br9 0.2120  pearson
## 140    delta_cf_br15  delta_whole_br9 0.2539  pearson
## 141    delta_cf_br16  delta_whole_br9 0.2458  pearson
## 142 delta_whole_br10  delta_whole_br9 0.4511  pearson
## 143  delta_whole_br8  delta_whole_br9 0.6667  pearson
## 144  delta_whole_br9  delta_whole_br9 1.0000  pearson
## 146     comp_cf_br18     comp_cf_br17 0.7555 spearman
## 147     comp_cf_br19     comp_cf_br17 0.7859 spearman
## 148  comp_whole_br11     comp_cf_br17 0.1744 spearman
## 149  comp_whole_br12     comp_cf_br17 0.1767 spearman
## 150  comp_whole_br13     comp_cf_br17 0.1515 spearman
## 151    delta_cf_br14     comp_cf_br17 0.6998 spearman
## 152    delta_cf_br15     comp_cf_br17 0.7708 spearman
## 153    delta_cf_br16     comp_cf_br17 0.7897 spearman
## 154 delta_whole_br10     comp_cf_br17 0.3836 spearman
## 155  delta_whole_br8     comp_cf_br17 0.1618 spearman
## 156  delta_whole_br9     comp_cf_br17 0.1634 spearman
## 159     comp_cf_br19     comp_cf_br18 0.7763 spearman
## 160  comp_whole_br11     comp_cf_br18 0.1644 spearman
## 161  comp_whole_br12     comp_cf_br18 0.1701 spearman
## 162  comp_whole_br13     comp_cf_br18 0.1450 spearman
## 163    delta_cf_br14     comp_cf_br18 0.6808 spearman
## 164    delta_cf_br15     comp_cf_br18 0.7498 spearman
## 165    delta_cf_br16     comp_cf_br18 0.7343 spearman
## 166 delta_whole_br10     comp_cf_br18 0.3723 spearman
## 167  delta_whole_br8     comp_cf_br18 0.1558 spearman
## 168  delta_whole_br9     comp_cf_br18 0.1554 spearman
## 172  comp_whole_br11     comp_cf_br19 0.1673 spearman
## 173  comp_whole_br12     comp_cf_br19 0.1885 spearman
## 174  comp_whole_br13     comp_cf_br19 0.1633 spearman
## 175    delta_cf_br14     comp_cf_br19 0.6945 spearman
## 176    delta_cf_br15     comp_cf_br19 0.7640 spearman
## 177    delta_cf_br16     comp_cf_br19 0.7528 spearman
## 178 delta_whole_br10     comp_cf_br19 0.3863 spearman
## 179  delta_whole_br8     comp_cf_br19 0.1770 spearman
## 180  delta_whole_br9     comp_cf_br19 0.1773 spearman
## 185  comp_whole_br12  comp_whole_br11 0.1235 spearman
## 186  comp_whole_br13  comp_whole_br11 0.1247 spearman
## 187    delta_cf_br14  comp_whole_br11 0.1921 spearman
## 188    delta_cf_br15  comp_whole_br11 0.1755 spearman
## 189    delta_cf_br16  comp_whole_br11 0.1778 spearman
## 190 delta_whole_br10  comp_whole_br11 0.1833 spearman
## 191  delta_whole_br8  comp_whole_br11 0.1279 spearman
## 192  delta_whole_br9  comp_whole_br11 0.1310 spearman
## 198  comp_whole_br13  comp_whole_br12 0.7067 spearman
## 199    delta_cf_br14  comp_whole_br12 0.1263 spearman
## 200    delta_cf_br15  comp_whole_br12 0.1547 spearman
## 201    delta_cf_br16  comp_whole_br12 0.1569 spearman
## 202 delta_whole_br10  comp_whole_br12 0.3757 spearman
## 203  delta_whole_br8  comp_whole_br12 0.6964 spearman
## 204  delta_whole_br9  comp_whole_br12 0.6847 spearman
## 211    delta_cf_br14  comp_whole_br13 0.1099 spearman
## 212    delta_cf_br15  comp_whole_br13 0.1354 spearman
## 213    delta_cf_br16  comp_whole_br13 0.1374 spearman
## 214 delta_whole_br10  comp_whole_br13 0.3456 spearman
## 215  delta_whole_br8  comp_whole_br13 0.7034 spearman
## 216  delta_whole_br9  comp_whole_br13 0.6806 spearman
## 224    delta_cf_br15    delta_cf_br14 0.7563 spearman
## 225    delta_cf_br16    delta_cf_br14 0.7500 spearman
## 226 delta_whole_br10    delta_cf_br14 0.3277 spearman
## 227  delta_whole_br8    delta_cf_br14 0.1167 spearman
## 228  delta_whole_br9    delta_cf_br14 0.1163 spearman
## 237    delta_cf_br16    delta_cf_br15 0.8001 spearman
## 238 delta_whole_br10    delta_cf_br15 0.3577 spearman
## 239  delta_whole_br8    delta_cf_br15 0.1468 spearman
## 240  delta_whole_br9    delta_cf_br15 0.1515 spearman
## 250 delta_whole_br10    delta_cf_br16 0.3648 spearman
## 251  delta_whole_br8    delta_cf_br16 0.1473 spearman
## 252  delta_whole_br9    delta_cf_br16 0.1476 spearman
## 263  delta_whole_br8 delta_whole_br10 0.3537 spearman
## 264  delta_whole_br9 delta_whole_br10 0.3534 spearman
## 276  delta_whole_br9  delta_whole_br8 0.6829 spearman
## I have no effing clue what this plot means.
variation <- SWATH2stats::plot_variation(s2s_exp, fun.aggregate=sum,
                                         Comparison=transition_group_id ~ Condition)
## Error: value.var (Intensity) not found in input
## Something in SWATH2stats::disaggregate was written poorly and is looking for
## a variable named 'cols'
cols <- colnames(only_minimum)
## Error in is.data.frame(x): object 'only_minimum' not found
disaggregated <- SWATH2stats::disaggregate(s2s_exp, all.columns=TRUE)
## The library contains between 4 and 6 transitions per precursor.
## The data table was transformed into a table containing one row per transition.
msstats_input <- SWATH2stats::convert4MSstats(disaggregated)
## One or several columns required by MSstats were not in the data. The columns were created and filled with NAs.
## Missing columns: fragmention, productcharge, isotopelabeltype
## isotopelabeltype was filled with light.
alfq_input <- sm(SWATH2stats::convert4aLFQ(disaggregated))
## Error in `[.data.frame`(data, , c("ProteinName", "PeptideSequence", "FragmentIon", : undefined columns selected
mapdia_input <- sm(SWATH2stats::convert4mapDIA(disaggregated, RT=TRUE))
## Error in apply(data.red.wide.test[, 4:dim(data.red.wide.test)[2]], 2, : dim(X) must have a positive length

3.1 MSstats

msstats.org seems to provide a complete solution for performing reasonable metrics of this data.

I am currently reading: http://msstats.org/wp-content/uploads/2017/01/MSstats_v3.7.3_manual.pdf

I made some moderately intrusive changes to MSstats to make it clearer, as well.

devtools::load_all("~/scratch/git/MSstats")
## Loading MSstats
## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)

## Warning: character(0)
msstats_quant <- MSstats::dataProcess(msstats_input)
## 2018-05-16 17:37:23 WARNING::The required inputs: ISOTOPLABELCHARGE were not provided. the required inputs are: 
## Proteinname, PeptideSequence/PeptideModifiedSequence, PrecursorCharge, FragmentIon,
## ProductCharge, IsotopeLabelType, Condition, BioReplicate, Run, Intensity.
## The provided inputs are: PROTEINNAME, PEPTIDESEQUENCE, PRECURSORCHARGE, FRAGMENTION, PRODUCTCHARGE, ISOTOPELABELTYPE, INTENSITY, BIOREPLICATE, CONDITION, RUN
## 2018-05-16 17:37:23 INFO::The summary method is: TMP
## 2018-05-16 17:37:23 INFO::The cutoff censor method is: minFeature.
## 2018-05-16 17:37:23 INFO::The censored int is: NA
## 2018-05-16 17:37:25 INFO::Data successfully reformatted for further analyses.
## 2018-05-16 17:37:25 INFO::Log 2 transformation complete.
## 2018-05-16 17:37:25 INFO::The fillincomplete rows option is: TRUE
## 2018-05-16 17:37:27 WARNING::CAUTION: the input dataset has incomplete rows. If missing peaks
##  occur they should be included in the dataset as separate rows, and the missing intensity
##  values should be indicated with 'NA'. The incomplete rows are listed below.
## 2018-05-16 17:37:27 INFO::*** Subject : br14, Condition : delta_cf has incomplete rows for
##  2018-05-16 17:37:27 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAADQLQTWAAR_2_NA_NA
## 2018-05-16 17:37:27 INFO::*** Subject : br15, Condition : delta_cf has incomplete rows for
##  2018-05-16 17:37:27 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAADQLQTWAAR_2_NA_NA
## 2018-05-16 17:37:27 INFO::*** Subject : br16, Condition : delta_cf has incomplete rows for
##  2018-05-16 17:37:27 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA,
##  2018-05-16 17:37:27 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA
## 2018-05-16 17:37:28 INFO::*** Subject : br17, Condition : comp_cf has incomplete rows for
##  2018-05-16 17:37:28 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAADQLQTWAAR_2_NA_NA
## 2018-05-16 17:37:28 INFO::*** Subject : br18, Condition : comp_cf has incomplete rows for
##  2018-05-16 17:37:28 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAADQLQTWAAR_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAELADWM(UniMod_35)QSPEGQASSLESIGR_3_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAGLVTVHGDATK_2_NA_NA
## 2018-05-16 17:37:28 INFO::*** Subject : br19, Condition : comp_cf has incomplete rows for
##  2018-05-16 17:37:28 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA,
##  2018-05-16 17:37:28 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAADQLQTWAAR_2_NA_NA
## 2018-05-16 17:37:29 INFO::*** Subject : br8, Condition : delta_whole has incomplete rows for
##  2018-05-16 17:37:29 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAVYEAAR_2_NA_NA, AAADAVAAQVGIDSAVADMLPEGK_3_NA_NA,
##  2018-05-16 17:37:29 INFO::AAADEALAAIPDC(UniMod_4)SVEHVLVVR_3_NA_NA
## 2018-05-16 17:37:29 INFO::*** Subject : br9, Condition : delta_whole has incomplete rows for
##  2018-05-16 17:37:29 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAGLVTVHGDATK_2_NA_NA, AAAAHAAAAGR_2_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAANNWIDER_2_NA_NA, AAAATFDR_2_NA_NA
## 2018-05-16 17:37:29 INFO::*** Subject : br10, Condition : delta_whole has incomplete rows
##  2018-05-16 17:37:29 INFO::for some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA,
##  2018-05-16 17:37:29 INFO::AAAAGGQVIAEPADIPSVGR_3_NA_NA
## 2018-05-16 17:37:30 INFO::*** Subject : br11, Condition : comp_whole has incomplete rows for
##  2018-05-16 17:37:30 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:30 INFO::AAAAAAPPPLDVMAALR_2_NA_NA,
##  2018-05-16 17:37:30 INFO::AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:30 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:30 INFO::AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA
## 2018-05-16 17:37:30 INFO::*** Subject : br12, Condition : comp_whole has incomplete rows for
##  2018-05-16 17:37:30 INFO::some features (AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAANNWIDER_2_NA_NA,
##  2018-05-16 17:37:30 INFO::AAAANPPMIR_2_NA_NA, AAAAVYEAAR_2_NA_NA,
##  2018-05-16 17:37:30 INFO::AAADAVAAQVGIDSAVADMLPEGK_3_NA_NA,
##  2018-05-16 17:37:30 INFO::AAADEALAAIPDC(UniMod_4)SVEHVLVVR_3_NA_NA
## 2018-05-16 17:37:31 INFO::*** Subject : br13, Condition : comp_whole has incomplete rows for
##  2018-05-16 17:37:31 INFO::some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA,
##  2018-05-16 17:37:31 INFO::AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA,
##  2018-05-16 17:37:31 INFO::AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAANPPMIR_2_NA_NA,
##  2018-05-16 17:37:31 INFO::AAAATFDR_2_NA_NA, AAAAVYEAAR_2_NA_NA
## Incomplete rows for missing peaks are added with intensity values=NA.
## 2018-05-16 17:37:31 INFO::Incomplete rows for missing peaks are added with intensity values=NA.
## *** Subject : br14, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br14, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA)
## *** Subject : br15, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br15, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA)
## *** Subject : br16, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA, AAAAIGETDEYGR_2_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br16, Condition : delta_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA, AAAAIGETDEYGR_2_NA_NA)
## *** Subject : br17, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br17, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA, AAAAHVLPDAQLTAAEQR_3_NA_NA)
## *** Subject : br18, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br18, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA)
## *** Subject : br19, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br19, Condition : comp_cf has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_2_NA_NA, AAAAGGQVIAEPADIPSVGR_3_NA_NA, AAAAHVLPDAQLTAAEQR_2_NA_NA)
## *** Subject : br8, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## 2018-05-16 17:37:32 WARNING::*** Subject : br8, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## *** Subject : br9, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## 2018-05-16 17:37:33 WARNING::*** Subject : br9, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## *** Subject : br10, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAADQLQTWAAR_2_NA_NA, AAAAELADWM(UniMod_35)QSPEGQASSLESIGR_3_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA)
## 2018-05-16 17:37:33 WARNING::*** Subject : br10, Condition : delta_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA, AAAADQLQTWAAR_2_NA_NA, AAAAELADWM(UniMod_35)QSPEGQASSLESIGR_3_NA_NA, AAAAELADWMQSPEGQASSLESIGR_3_NA_NA)
## *** Subject : br11, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAGVTAVVTVADDLESAR_2_NA_NA, AAFDYADGGAEDELSIAR_2_NA_NA, AALEASLAAVEEGAFAR_2_NA_NA, AAQLGIELLSLDDLLAR_2_NA_NA, ADAAVAAGADVVGSDDLIER_2_NA_NA, ADAVDDEELLELVEMEVR_3_NA_NA)
## 2018-05-16 17:37:33 WARNING::*** Subject : br11, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAGVTAVVTVADDLESAR_2_NA_NA, AAFDYADGGAEDELSIAR_2_NA_NA, AALEASLAAVEEGAFAR_2_NA_NA, AAQLGIELLSLDDLLAR_2_NA_NA, ADAAVAAGADVVGSDDLIER_2_NA_NA, ADAVDDEELLELVEMEVR_3_NA_NA)
## *** Subject : br12, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA, AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA)
## 2018-05-16 17:37:33 WARNING::*** Subject : br12, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVM(UniMod_35)AALR_2_NA_NA, AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADPGPPTRPAHNAAGVSPEMVQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA)
## *** Subject : br13, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## 2018-05-16 17:37:33 WARNING::*** Subject : br13, Condition : comp_whole has multiple rows (duplicate rows) for some features (AAAAAAPPPLDVMAALR_2_NA_NA, AAAAADPGPPTRPAHNAAGVSPEM(UniMod_35)VQVPAEAQR_4_NA_NA, AAAAADVVILDLEDGVAEAQKPAAR_3_NA_NA, AAAAAGASGFYAK_2_NA_NA, AAAAAPQAPPKPADTAAAGNGVVAALAAK_3_NA_NA, AAAAAPSGTAVGAGAR_2_NA_NA)
## 2018-05-16 17:37:33 WARNING::Please remove duplicate rows in the list above.
## 2018-05-16 17:37:35 INFO::Recast the following columns as factors:
## group, subject, group_original, subject_original, subject_original_nested, feature, and run.
## 2018-05-16 17:37:36 INFO::Performing equalize medians normalization.
## 2018-05-16 17:37:36 INFO::Between run interference score was not calculated.
## 2018-05-16 17:37:36 INFO::** Log2 intensities under cutoff =12.546 were considered as censored missing values.
## 2018-05-16 17:37:36 INFO::** Log2 intensities = NA were considered as censored missing values.
## 2018-05-16 17:37:36 INFO::Feature Subset: using all features in the data set.
## 2018-05-16 17:37:36 INFO::Summary: 1 levels of isotope labeling were observed.
## 2018-05-16 17:37:37 INFO::Summary of Features:
## 2018-05-16 17:37:37 INFO::Number of Proteins : 2614
## 2018-05-16 17:37:37 INFO::Number of Peptides/Protein : 1-117
## 2018-05-16 17:37:37 INFO::Number of Transitions/Peptide : 1-1
## 2018-05-16 17:37:37 INFO::Proteins: 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 253, 254, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 336, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471 have only single transitions, consider removing them from the dataset.
##                       
##   Summary of Samples :
## 2018-05-16 17:37:37 INFO::comp_cf   comp_whole   delta_cf   delta_whole
##  2018-05-16 17:37:37 INFO::--------------------------------  --------  -----------  ---------  ------------
##  2018-05-16 17:37:37 INFO::Number of MS runs                        3            3          3             3
##  2018-05-16 17:37:37 INFO::Number of Biological Replicates          3            3          3             3
##  2018-05-16 17:37:37 INFO::Number of Technical Replicates           1            1          1             1
## 2018-05-16 17:37:37 INFO::Missingness summary: 13319 are missing completely in one condition.
## 2018-05-16 17:37:37 INFO::-> AFAEAVEDFHAEADADFPGGM(UniMod_35)K_3_NA_NA, APITDALSR_2_NA_NA, AYNPLFIWGESGLGK_2_NA_NA, DHTTVMYAQR_2_NA_NA, ELEGALIR_2_NA_NA ...
## 2018-05-16 17:37:37 INFO::Missingness summary: 0 are missing 75% observations.
## 2018-05-16 17:37:37 INFO::-> AFAEAVEDFHAEADADFPGGM(UniMod_35)K_3_NA_NA, APITDALSR_2_NA_NA, AYNPLFIWGESGLGK_2_NA_NA, DHTTVMYAQR_2_NA_NA, ELEGALIR_2_NA_NA ...
## 2018-05-16 17:37:37 INFO::Processing data for analysis is complete.
## 
  |                                                                       
  |                                                                 |   0%
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## Warning in medpolish(modified_data_w, na.rm = TRUE, trace.iter = FALSE):
## medpolish() did not converge in 10 iterations
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## Warning in medpolish(modified_data_w, na.rm = TRUE, trace.iter = FALSE):
## medpolish() did not converge in 10 iterations
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## Warning in medpolish(modified_data_w, na.rm = TRUE, trace.iter = FALSE):
## medpolish() did not converge in 10 iterations
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## Warning in medpolish(modified_data_w, na.rm = TRUE, trace.iter = FALSE):
## medpolish() did not converge in 10 iterations
## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge

## Warning in survreg.fit(X, Y, weights, offset, init = init, controlvals =
## control, : Ran out of iterations and did not converge
## 
## 2018-05-16 17:40:18 INFO::The summarization per subplot by method: TMP is finished.
msstats_plots <- MSstats::dataProcessPlots(msstats_quant, type="QCPLOT")
## Writing plots to: QCPlot.pdf
## Warning: Removed 119463 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for all proteins.
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/DECOY_Rv3047c_UNMAPPED ( 1  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0001 ( 2  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0002 ( 3  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0003 ( 4  of  2614 )
## Warning: Removed 226 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0005 ( 5  of  2614 )
## Warning: Removed 153 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0006 ( 6  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0007 ( 7  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0008c ( 8  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0009 ( 9  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0010c ( 10  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0011c ( 11  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0012 ( 12  of  2614 )
## Warning: Removed 125 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0014c ( 13  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0015c ( 14  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0016c ( 15  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0017c ( 16  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0018c ( 17  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0019c ( 18  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0020c ( 19  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0023 ( 20  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0025 ( 21  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0027 ( 22  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0029 ( 23  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0032 ( 24  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0034 ( 25  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0035 ( 26  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0036c ( 27  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0037c ( 28  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0038 ( 29  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0040c ( 30  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0041 ( 31  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0042c ( 32  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0043c ( 33  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0044c ( 34  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0045c ( 35  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0046c ( 36  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0047c ( 37  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0048c ( 38  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0050 ( 39  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0051 ( 40  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0052 ( 41  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0053 ( 42  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0054 ( 43  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0055 ( 44  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0056 ( 45  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0058 ( 46  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0059 ( 47  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0060 ( 48  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0061c ( 49  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0062 ( 50  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0063 ( 51  of  2614 )
## Warning: Removed 152 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0066c ( 52  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0068 ( 53  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0069c ( 54  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0070c ( 55  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0072 ( 56  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0073 ( 57  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0074 ( 58  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0075 ( 59  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0077c ( 60  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0078 ( 61  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0078A ( 62  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0079 ( 63  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0081 ( 64  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0087 ( 65  of  2614 )
## Warning: Removed 89 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0088 ( 66  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0091 ( 67  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0092 ( 68  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0097 ( 69  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0098 ( 70  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0099 ( 71  of  2614 )
## Warning: Removed 126 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0101 ( 72  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0103c ( 73  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0107c ( 74  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0108c ( 75  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0116c ( 76  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0117 ( 77  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0118c ( 78  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0119 ( 79  of  2614 )
## Warning: Removed 128 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0120c ( 80  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0121c ( 81  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0123 ( 82  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0125 ( 83  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0126 ( 84  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0127 ( 85  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0129c ( 86  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0130 ( 87  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0131c ( 88  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0134 ( 89  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0135c ( 90  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0136 ( 91  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0137c ( 92  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0138 ( 93  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0139 ( 94  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0140 ( 95  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0141c ( 96  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0144 ( 97  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0145 ( 98  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0146 ( 99  of  2614 )
## Warning: Removed 113 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0147 ( 100  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0148 ( 101  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0149 ( 102  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0153c ( 103  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0154c ( 104  of  2614 )
## Warning: Removed 96 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0155 ( 105  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0157 ( 106  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0157A ( 107  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0158 ( 108  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0161 ( 109  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0162c ( 110  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0163 ( 111  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0164 ( 112  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0166 ( 113  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0169 ( 114  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0170 ( 115  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0171 ( 116  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0172 ( 117  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0173 ( 118  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0174 ( 119  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0175 ( 120  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0176 ( 121  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0177 ( 122  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0178 ( 123  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0179c ( 124  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0180c ( 125  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0181c ( 126  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0182c ( 127  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0183 ( 128  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0184 ( 129  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0185 ( 130  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0186 ( 131  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0186A ( 132  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0187 ( 133  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0189c ( 134  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0190 ( 135  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0196 ( 136  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0198c ( 137  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0199 ( 138  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0200 ( 139  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0201c ( 140  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0202c ( 141  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0203 ( 142  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0204c ( 143  of  2614 )
## Warning: Removed 118 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0206c ( 144  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0207c ( 145  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0208c ( 146  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0211 ( 147  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0214 ( 148  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0215c ( 149  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0216 ( 150  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0217c ( 151  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0220 ( 152  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0221 ( 153  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0222 ( 154  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0223c ( 155  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0226c ( 156  of  2614 )
## Warning: Removed 105 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0227c ( 157  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0229c ( 158  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0230c ( 159  of  2614 )
## Warning: Removed 141 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0231 ( 160  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0232 ( 161  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0233 ( 162  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0234c ( 163  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0237 ( 164  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0238 ( 165  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0239 ( 166  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0241c ( 167  of  2614 )
## Warning: Removed 134 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0242c ( 168  of  2614 )
## Warning: Removed 146 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0243 ( 169  of  2614 )
## Warning: Removed 153 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0244c ( 170  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0245 ( 171  of  2614 )
## Warning: Removed 120 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0247c ( 172  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0248c ( 173  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0249c ( 174  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0250c ( 175  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0255c ( 176  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0256c ( 177  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0262c ( 178  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0263c ( 179  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0265c ( 180  of  2614 )
## Warning: Removed 149 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0266c ( 181  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0269c ( 182  of  2614 )
## Warning: Removed 172 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0270 ( 183  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0271c ( 184  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0272c ( 185  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0274 ( 186  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0276 ( 187  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0281 ( 188  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0282 ( 189  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0283 ( 190  of  2614 )
## Warning: Removed 190 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0284 ( 191  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0285 ( 192  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0286 ( 193  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0287 ( 194  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0288 ( 195  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0289 ( 196  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0290 ( 197  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0291 ( 198  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0292 ( 199  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0293c ( 200  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0294 ( 201  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0295c ( 202  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0296c ( 203  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0298 ( 204  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0300 ( 205  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0301 ( 206  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0303 ( 207  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0307c ( 208  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0308 ( 209  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0309 ( 210  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0310c ( 211  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0311 ( 212  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0312 ( 213  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0313 ( 214  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0315 ( 215  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0316 ( 216  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0317c ( 217  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0321 ( 218  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0324 ( 219  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0328 ( 220  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0329c ( 221  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0331 ( 222  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0332 ( 223  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0333 ( 224  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0334 ( 225  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0337c ( 226  of  2614 )
## Warning: Removed 150 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0338c ( 227  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0339c ( 228  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0340 ( 229  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0341 ( 230  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0342 ( 231  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0343 ( 232  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0344c ( 233  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0347 ( 234  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0348 ( 235  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0349 ( 236  of  2614 )
## Warning: Removed 177 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0350 ( 237  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0351 ( 238  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0352 ( 239  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0353 ( 240  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0356c ( 241  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0357c ( 242  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0360c ( 243  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0361 ( 244  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0363c ( 245  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0365c ( 246  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0367c ( 247  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0376c ( 248  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0379 ( 249  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0382c ( 250  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0383c ( 251  of  2614 )
## Warning: Removed 225 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0384c ( 252  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0386 ( 253  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0389 ( 254  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0390 ( 255  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0391 ( 256  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0392c ( 257  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0394c ( 258  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0397A ( 259  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0398c ( 260  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0400c ( 261  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0404 ( 262  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0405 ( 263  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0406c ( 264  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0407 ( 265  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0408 ( 266  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0409 ( 267  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0410c ( 268  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0411c ( 269  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0412c ( 270  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0413 ( 271  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0414c ( 272  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0415 ( 273  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0417 ( 274  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0418 ( 275  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0419 ( 276  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0421c ( 277  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0422c ( 278  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0423c ( 279  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0424c ( 280  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0425c ( 281  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0426c ( 282  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0427c ( 283  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0428c ( 284  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0430 ( 285  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0431 ( 286  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0432 ( 287  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0433 ( 288  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0434 ( 289  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0435c ( 290  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0436c ( 291  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0437c ( 292  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0438c ( 293  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0439c ( 294  of  2614 )
## Warning: Removed 251 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0440 ( 295  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0441c ( 296  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0442c ( 297  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0443 ( 298  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0444c ( 299  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0445c ( 300  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0450c ( 301  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0455c ( 302  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0456c ( 303  of  2614 )
## Warning: Removed 98 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0457c ( 304  of  2614 )
## Warning: Removed 97 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0458 ( 305  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0459 ( 306  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0461 ( 307  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0462 ( 308  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0464c ( 309  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0466 ( 310  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0467 ( 311  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0468 ( 312  of  2614 )
## Warning: Removed 102 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0469 ( 313  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0470c ( 314  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0472c ( 315  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0473 ( 316  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0474 ( 317  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0475 ( 318  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0477 ( 319  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0478 ( 320  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0479c ( 321  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0480c ( 322  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0481c ( 323  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0482 ( 324  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0483 ( 325  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0484c ( 326  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0485 ( 327  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0486 ( 328  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0487 ( 329  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0489 ( 330  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0490 ( 331  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0491 ( 332  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0492c ( 333  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0493c ( 334  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0495c ( 335  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0496 ( 336  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0497 ( 337  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0498 ( 338  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0499 ( 339  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0500 ( 340  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0500A ( 341  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0501 ( 342  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0502 ( 343  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0503c ( 344  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0504c ( 345  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0505c ( 346  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0508 ( 347  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0509 ( 348  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0510 ( 349  of  2614 )
## Warning: Removed 152 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0511 ( 350  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0512 ( 351  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0513 ( 352  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0516c ( 353  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0517 ( 354  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0518 ( 355  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0519c ( 356  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0523c ( 357  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0524 ( 358  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0525 ( 359  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0526 ( 360  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0528 ( 361  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0529 ( 362  of  2614 )
## Warning: Removed 121 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0530 ( 363  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0530A ( 364  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0531 ( 365  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0533c ( 366  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0536 ( 367  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0537c ( 368  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0538 ( 369  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0539 ( 370  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0540 ( 371  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0542c ( 372  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0543c ( 373  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0544c ( 374  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0545c ( 375  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0546c ( 376  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0547c ( 377  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0548c ( 378  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0550c ( 379  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0551c ( 380  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0552 ( 381  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0553 ( 382  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0554 ( 383  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0555 ( 384  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0556 ( 385  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0558 ( 386  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0559c ( 387  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0560c ( 388  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0561c ( 389  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0562 ( 390  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0563 ( 391  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0564c ( 392  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0565c ( 393  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0566c ( 394  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0567 ( 395  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0568 ( 396  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0569 ( 397  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0571c ( 398  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0576 ( 399  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0577 ( 400  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0578c ( 401  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0580c ( 402  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0581 ( 403  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0582 ( 404  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0583c ( 405  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0586 ( 406  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0595c ( 407  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0596c ( 408  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0597c ( 409  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0598c ( 410  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0599c ( 411  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0604 ( 412  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0609 ( 413  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0610c ( 414  of  2614 )
## Warning: Removed 188 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0613c ( 415  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0616A ( 416  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0617 ( 417  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0623 ( 418  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0626 ( 419  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0628c ( 420  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0629c ( 421  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0630c ( 422  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0631c ( 423  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0632c ( 424  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0633c ( 425  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0634A ( 426  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0634B ( 427  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0634c ( 428  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0635 ( 429  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0636 ( 430  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0637 ( 431  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0638 ( 432  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0639 ( 433  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0640 ( 434  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0641 ( 435  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0642c ( 436  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0643c ( 437  of  2614 )
## Warning: Removed 102 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0644c ( 438  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0645c ( 439  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0646c ( 440  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0647c ( 441  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0651 ( 442  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0652 ( 443  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0653c ( 444  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0654 ( 445  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0655 ( 446  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0660c ( 447  of  2614 )
## Warning: Removed 320 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0667 ( 448  of  2614 )
## Warning: Removed 453 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0668 ( 449  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0669c ( 450  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0670 ( 451  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0671 ( 452  of  2614 )
## Warning: Removed 125 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0672 ( 453  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0673 ( 454  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0675 ( 455  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0676c ( 456  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0677c ( 457  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0678 ( 458  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0679c ( 459  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0680c ( 460  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0681 ( 461  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0682 ( 462  of  2614 )
## Warning: Removed 104 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0683 ( 463  of  2614 )
## Warning: Removed 213 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0684 ( 464  of  2614 )
## Warning: Removed 149 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0685 ( 465  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0686 ( 466  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0687 ( 467  of  2614 )
## Warning: Removed 168 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0688 ( 468  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0690c ( 469  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0694 ( 470  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0695 ( 471  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0696 ( 472  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0700 ( 473  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0701 ( 474  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0702 ( 475  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0703 ( 476  of  2614 )
## Warning: Removed 128 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0704 ( 477  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0705 ( 478  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0706 ( 479  of  2614 )
## Warning: Removed 137 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0707 ( 480  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0708 ( 481  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0709 ( 482  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0710 ( 483  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0711 ( 484  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0712 ( 485  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0714 ( 486  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0715 ( 487  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0716 ( 488  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0717 ( 489  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0718 ( 490  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0719 ( 491  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0720 ( 492  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0721 ( 493  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0722 ( 494  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0723 ( 495  of  2614 )
## Warning: Removed 165 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0724 ( 496  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0726c ( 497  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0729 ( 498  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0730 ( 499  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0731c ( 500  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0732 ( 501  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0733 ( 502  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0734 ( 503  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0736 ( 504  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0737 ( 505  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0738 ( 506  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0740 ( 507  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0743c ( 508  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0744c ( 509  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0748 ( 510  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0751c ( 511  of  2614 )
## Warning: Removed 108 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0752c ( 512  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0753c ( 513  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0757 ( 514  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0758 ( 515  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0759c ( 516  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0760c ( 517  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0761c ( 518  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0763c ( 519  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0764c ( 520  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0765c ( 521  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0766c ( 522  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0767c ( 523  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0768 ( 524  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0769 ( 525  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0770 ( 526  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0772 ( 527  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0773c ( 528  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0774c ( 529  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0777 ( 530  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0778 ( 531  of  2614 )
## Warning: Removed 148 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0780 ( 532  of  2614 )
## Warning: Removed 118 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0785 ( 533  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0786c ( 534  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0787A ( 535  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0788 ( 536  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0790c ( 537  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0791c ( 538  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0794c ( 539  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0798c ( 540  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0799c ( 541  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0800 ( 542  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0801 ( 543  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0802c ( 544  of  2614 )
## Warning: Removed 106 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0803 ( 545  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0805 ( 546  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0806c ( 547  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0807 ( 548  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0808 ( 549  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0809 ( 550  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0810c ( 551  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0811c ( 552  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0812 ( 553  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0813c ( 554  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0817c ( 555  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0818 ( 556  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0819 ( 557  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0820 ( 558  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0821c ( 559  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0822c ( 560  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0823c ( 561  of  2614 )
## Warning: Removed 95 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0824c ( 562  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0825c ( 563  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0827c ( 564  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0830 ( 565  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0831c ( 566  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0835 ( 567  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0838 ( 568  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0840c ( 569  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0844c ( 570  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0845 ( 571  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0846c ( 572  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0852 ( 573  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0853c ( 574  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0854 ( 575  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0855 ( 576  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0857 ( 577  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0858c ( 578  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0859 ( 579  of  2614 )
## Warning: Removed 209 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0860 ( 580  of  2614 )
## Warning: Removed 160 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0861c ( 581  of  2614 )
## Warning: Removed 126 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0862c ( 582  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0863 ( 583  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0864 ( 584  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0865 ( 585  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0868c ( 586  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0871 ( 587  of  2614 )
## Warning: Removed 204 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0873 ( 588  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0875c ( 589  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0876c ( 590  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0877 ( 591  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0880 ( 592  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0883c ( 593  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0884c ( 594  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0886 ( 595  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0887c ( 596  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0888 ( 597  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0889c ( 598  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0890c ( 599  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0892 ( 600  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0893c ( 601  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0896 ( 602  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0897c ( 603  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0898c ( 604  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0899 ( 605  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0901 ( 606  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0902c ( 607  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0903c ( 608  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0904c ( 609  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0905 ( 610  of  2614 )
## Warning: Removed 79 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0906 ( 611  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0907 ( 612  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0908 ( 613  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0909 ( 614  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0910 ( 615  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0911 ( 616  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0913c ( 617  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0914c ( 618  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0923c ( 619  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0925c ( 620  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0926c ( 621  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0927c ( 622  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0928 ( 623  of  2614 )
## Warning: Removed 183 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0931c ( 624  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0932c ( 625  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0933 ( 626  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0934 ( 627  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0936 ( 628  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0937c ( 629  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0938 ( 630  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0939 ( 631  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0940c ( 632  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0941c ( 633  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0946c ( 634  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0948c ( 635  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0949 ( 636  of  2614 )
## Warning: Removed 116 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0951 ( 637  of  2614 )
## Warning: Removed 89 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0952 ( 638  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0953c ( 639  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0954 ( 640  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0956 ( 641  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0957 ( 642  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0958 ( 643  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0959 ( 644  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0959A ( 645  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0960 ( 646  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0966c ( 647  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0967 ( 648  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0968 ( 649  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0969 ( 650  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0971c ( 651  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0972c ( 652  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0973c ( 653  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0974c ( 654  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0979A ( 655  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0981 ( 656  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0982 ( 657  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0983 ( 658  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0984 ( 659  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0985c ( 660  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0986 ( 661  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0989c ( 662  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0991c ( 663  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0992c ( 664  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0993 ( 665  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0994 ( 666  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0997a ( 667  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0998 ( 668  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv0999 ( 669  of  2614 )
## Warning: Removed 98 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1001 ( 670  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1002c ( 671  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1003 ( 672  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1005c ( 673  of  2614 )
## Warning: Removed 116 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1006 ( 674  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1007c ( 675  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1008 ( 676  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1009 ( 677  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1010 ( 678  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1011 ( 679  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1013 ( 680  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1015c ( 681  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1016c ( 682  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1017c ( 683  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1018c ( 684  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1019 ( 685  of  2614 )
## Warning: Removed 199 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1020 ( 686  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1021 ( 687  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1022 ( 688  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1023 ( 689  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1024 ( 690  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1025 ( 691  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1026 ( 692  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1028c ( 693  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1030 ( 694  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1032c ( 695  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1033c ( 696  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1043c ( 697  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1045 ( 698  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1048c ( 699  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1050 ( 700  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1056 ( 701  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1058 ( 702  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1059 ( 703  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1060 ( 704  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1061 ( 705  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1062 ( 706  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1063c ( 707  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1069c ( 708  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1070c ( 709  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1071c ( 710  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1072 ( 711  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1074c ( 712  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1077 ( 713  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1078 ( 714  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1079 ( 715  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1080c ( 716  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1082 ( 717  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1083 ( 718  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1084 ( 719  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1086 ( 720  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1087 ( 721  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1092c ( 722  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1093 ( 723  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1094 ( 724  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1095 ( 725  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1096 ( 726  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1097c ( 727  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1098c ( 728  of  2614 )
## Warning: Removed 95 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1099c ( 729  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1100 ( 730  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1101c ( 731  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1106c ( 732  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1107c ( 733  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1108c ( 734  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1109c ( 735  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1110 ( 736  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1111c ( 737  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1112 ( 738  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1113 ( 739  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1117 ( 740  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1118c ( 741  of  2614 )
## Warning: Removed 116 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1121 ( 742  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1122 ( 743  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1123c ( 744  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1124 ( 745  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1125 ( 746  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1126c ( 747  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1127c ( 748  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1130 ( 749  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1132 ( 750  of  2614 )
## Warning: Removed 174 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1133c ( 751  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1140 ( 752  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1141c ( 753  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1142c ( 754  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1143 ( 755  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1144 ( 756  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1147 ( 757  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1151c ( 758  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1152 ( 759  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1154c ( 760  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1155 ( 761  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1155a ( 762  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1156 ( 763  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1157c ( 764  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1159A ( 765  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1160 ( 766  of  2614 )
## Warning: Removed 102 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1161 ( 767  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1162 ( 768  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1164 ( 769  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1165 ( 770  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1166 ( 771  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1167c ( 772  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1170 ( 773  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1172c ( 774  of  2614 )
## Warning: Removed 144 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1173 ( 775  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1174c ( 776  of  2614 )
## Warning: Removed 142 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1175c ( 777  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1176c ( 778  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1177 ( 779  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1178 ( 780  of  2614 )
## Warning: Removed 111 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1179c ( 781  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1180 ( 782  of  2614 )
## Warning: Removed 267 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1181 ( 783  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1182 ( 784  of  2614 )
## Warning: Removed 79 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1183 ( 785  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1184c ( 786  of  2614 )
## Warning: Removed 174 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1185c ( 787  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1187 ( 788  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1188 ( 789  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1191 ( 790  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1192 ( 791  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1193 ( 792  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1194c ( 793  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1196 ( 794  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1198 ( 795  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1201c ( 796  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1202 ( 797  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1204c ( 798  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1206 ( 799  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1207 ( 800  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1208 ( 801  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1209 ( 802  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1210 ( 803  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1211 ( 804  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1212c ( 805  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1213 ( 806  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1215c ( 807  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1218c ( 808  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1220c ( 809  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1223 ( 810  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1224 ( 811  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1226c ( 812  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1227c ( 813  of  2614 )
## Warning: Removed 121 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1229c ( 814  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1231c ( 815  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1232c ( 816  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1234 ( 817  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1235 ( 818  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1237 ( 819  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1238 ( 820  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1239c ( 821  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1240 ( 822  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1241 ( 823  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1244 ( 824  of  2614 )
## Warning: Removed 111 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1245c ( 825  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1246c ( 826  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1247c ( 827  of  2614 )
## Warning: Removed 293 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1248c ( 828  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1249c ( 829  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1251c ( 830  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1253 ( 831  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1255c ( 832  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1256c ( 833  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1257c ( 834  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1259 ( 835  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1260 ( 836  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1261c ( 837  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1263 ( 838  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1264 ( 839  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1265 ( 840  of  2614 )
## Warning: Removed 98 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1266c ( 841  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1267c ( 842  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1269c ( 843  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1270c ( 844  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1273c ( 845  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1274 ( 846  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1275 ( 847  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1276c ( 848  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1277 ( 849  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1278 ( 850  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1279 ( 851  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1280c ( 852  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1281c ( 853  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1283c ( 854  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1284 ( 855  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1285 ( 856  of  2614 )
## Warning: Removed 127 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1286 ( 857  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1287 ( 858  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1288 ( 859  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1289 ( 860  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1290c ( 861  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1292 ( 862  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1293 ( 863  of  2614 )
## Warning: Removed 104 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1294 ( 864  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1295 ( 865  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1296 ( 866  of  2614 )
## Warning: Removed 214 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1297 ( 867  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1298 ( 868  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1299 ( 869  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1301 ( 870  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1302 ( 871  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1304 ( 872  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1306 ( 873  of  2614 )
## Warning: Removed 120 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1307 ( 874  of  2614 )
## Warning: Removed 152 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1308 ( 875  of  2614 )
## Warning: Removed 148 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1309 ( 876  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1310 ( 877  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1311 ( 878  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1312 ( 879  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1314c ( 880  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1315 ( 881  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1316c ( 882  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1317c ( 883  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1318c ( 884  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1320c ( 885  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1321 ( 886  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1322 ( 887  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1322A ( 888  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1323 ( 889  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1324 ( 890  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1325c ( 891  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1326c ( 892  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1327c ( 893  of  2614 )
## Warning: Removed 218 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1328 ( 894  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1329c ( 895  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1330c ( 896  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1331 ( 897  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1332 ( 898  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1333 ( 899  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1334 ( 900  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1335 ( 901  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1336 ( 902  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1338 ( 903  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1339 ( 904  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1340 ( 905  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1341 ( 906  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1345 ( 907  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1346 ( 908  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1347c ( 909  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1348 ( 910  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1349 ( 911  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1350 ( 912  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1352 ( 913  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1360 ( 914  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1362c ( 915  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1363c ( 916  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1364c ( 917  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1366 ( 918  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1367c ( 919  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1368 ( 920  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1377c ( 921  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1379 ( 922  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1380 ( 923  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1381 ( 924  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1382 ( 925  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1383 ( 926  of  2614 )
## Warning: Removed 212 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1384 ( 927  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1385 ( 928  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1386 ( 929  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1387 ( 930  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1388 ( 931  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1389 ( 932  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1390 ( 933  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1391 ( 934  of  2614 )
## Warning: Removed 153 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1392 ( 935  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1398c ( 936  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1399c ( 937  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1400c ( 938  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1402 ( 939  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1404 ( 940  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1406 ( 941  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1407 ( 942  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1408 ( 943  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1409 ( 944  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1411c ( 945  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1412 ( 946  of  2614 )
## Warning: Removed 103 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1415 ( 947  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1416 ( 948  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1418 ( 949  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1419 ( 950  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1420 ( 951  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1421 ( 952  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1422 ( 953  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1423 ( 954  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1424c ( 955  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1425 ( 956  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1426c ( 957  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1427c ( 958  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1428c ( 959  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1429 ( 960  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1433 ( 961  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1435c ( 962  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1436 ( 963  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1437 ( 964  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1438 ( 965  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1439c ( 966  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1442 ( 967  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1443c ( 968  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1444c ( 969  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1445c ( 970  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1446c ( 971  of  2614 )
## Warning: Removed 108 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1447c ( 972  of  2614 )
## Warning: Removed 116 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1448c ( 973  of  2614 )
## Warning: Removed 104 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1449c ( 974  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1454c ( 975  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1455 ( 976  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1456c ( 977  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1458c ( 978  of  2614 )
## Warning: Removed 132 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1461 ( 979  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1462 ( 980  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1463 ( 981  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1464 ( 982  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1465 ( 983  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1466 ( 984  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1467c ( 985  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1471 ( 986  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1472 ( 987  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1473 ( 988  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1473A ( 989  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1474c ( 990  of  2614 )
## Warning: Removed 140 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1475c ( 991  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1476 ( 992  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1477 ( 993  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1478 ( 994  of  2614 )
## Warning: Removed 142 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1479 ( 995  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1480 ( 996  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1481 ( 997  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1483 ( 998  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1484 ( 999  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1486c ( 1000  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1487 ( 1001  of  2614 )
## Warning: Removed 119 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1488 ( 1002  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1489 ( 1003  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1492 ( 1004  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1493 ( 1005  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1494 ( 1006  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1496 ( 1007  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1497 ( 1008  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1498A ( 1009  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1498c ( 1010  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1500 ( 1011  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1501 ( 1012  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1502 ( 1013  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1507c ( 1014  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1508c ( 1015  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1511 ( 1016  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1512 ( 1017  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1513 ( 1018  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1514c ( 1019  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1515c ( 1020  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1516c ( 1021  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1521 ( 1022  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1523 ( 1023  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1524 ( 1024  of  2614 )
## Warning: Removed 162 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1527c ( 1025  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1529 ( 1026  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1530 ( 1027  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1531 ( 1028  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1532c ( 1029  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1533 ( 1030  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1534 ( 1031  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1535 ( 1032  of  2614 )
## Warning: Removed 103 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1536 ( 1033  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1538c ( 1034  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1540 ( 1035  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1543 ( 1036  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1544 ( 1037  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1546 ( 1038  of  2614 )
## Warning: Removed 125 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1547 ( 1039  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1556 ( 1040  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1558 ( 1041  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1559 ( 1042  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1561 ( 1043  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1562c ( 1044  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1563c ( 1045  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1564c ( 1046  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1565c ( 1047  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1566c ( 1048  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1569 ( 1049  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1570 ( 1050  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1571 ( 1051  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1576c ( 1052  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1578c ( 1053  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1586c ( 1054  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1589 ( 1055  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1590 ( 1056  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1591 ( 1057  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1592c ( 1058  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1593c ( 1059  of  2614 )
## Warning: Removed 103 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1594 ( 1060  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1595 ( 1061  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1596 ( 1062  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1597 ( 1063  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1598c ( 1064  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1599 ( 1065  of  2614 )
## Warning: Removed 114 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1600 ( 1066  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1601 ( 1067  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1602 ( 1068  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1603 ( 1069  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1605 ( 1070  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1606 ( 1071  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1608c ( 1072  of  2614 )
## Warning: Removed 139 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1609 ( 1073  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1610 ( 1074  of  2614 )
## Warning: Removed 123 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1611 ( 1075  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1612 ( 1076  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1613 ( 1077  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1614 ( 1078  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1615 ( 1079  of  2614 )
## Warning: Removed 134 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1617 ( 1080  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1618 ( 1081  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1620c ( 1082  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1621c ( 1083  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1622c ( 1084  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1623c ( 1085  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1625c ( 1086  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1626 ( 1087  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1627c ( 1088  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1628c ( 1089  of  2614 )
## Warning: Removed 183 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1629 ( 1090  of  2614 )
## Warning: Removed 106 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1630 ( 1091  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1631 ( 1092  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1632c ( 1093  of  2614 )
## Warning: Removed 141 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1633 ( 1094  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1636 ( 1095  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1637c ( 1096  of  2614 )
## Warning: Removed 196 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1638 ( 1097  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1638A ( 1098  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1640c ( 1099  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1641 ( 1100  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1642 ( 1101  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1643 ( 1102  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1647 ( 1103  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1649 ( 1104  of  2614 )
## Warning: Removed 171 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1650 ( 1105  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1652 ( 1106  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1653 ( 1107  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1654 ( 1108  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1655 ( 1109  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1656 ( 1110  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1657 ( 1111  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1658 ( 1112  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1659 ( 1113  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1660 ( 1114  of  2614 )
## Warning: Removed 97 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1661 ( 1115  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1663 ( 1116  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1664 ( 1117  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1665 ( 1118  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1666c ( 1119  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1676 ( 1120  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1677 ( 1121  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1679 ( 1122  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1680 ( 1123  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1681 ( 1124  of  2614 )
## Warning: Removed 189 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1683 ( 1125  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1684 ( 1126  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1685c ( 1127  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1686c ( 1128  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1687c ( 1129  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1688 ( 1130  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1689 ( 1131  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1691 ( 1132  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1692 ( 1133  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1695 ( 1134  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1696 ( 1135  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1697 ( 1136  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1698 ( 1137  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1699 ( 1138  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1700 ( 1139  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1701 ( 1140  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1703c ( 1141  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1704c ( 1142  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1707 ( 1143  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1708 ( 1144  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1710 ( 1145  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1711 ( 1146  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1712 ( 1147  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1713 ( 1148  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1719 ( 1149  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1721c ( 1150  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1722 ( 1151  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1727 ( 1152  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1729c ( 1153  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1730c ( 1154  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1731 ( 1155  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1732c ( 1156  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1738 ( 1157  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1742 ( 1158  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1743 ( 1159  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1745c ( 1160  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1746 ( 1161  of  2614 )
## Warning: Removed 148 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1747 ( 1162  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1748 ( 1163  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1749c ( 1164  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1750c ( 1165  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1751 ( 1166  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1754c ( 1167  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1762c ( 1168  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1767 ( 1169  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1769 ( 1170  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1770 ( 1171  of  2614 )
## Warning: Removed 134 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1771 ( 1172  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1773c ( 1173  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1774 ( 1174  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1778c ( 1175  of  2614 )
## Warning: Removed 81 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1779c ( 1176  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1780 ( 1177  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1781c ( 1178  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1782 ( 1179  of  2614 )
## Warning: Removed 247 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1783 ( 1180  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1785c ( 1181  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1789 ( 1182  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1793 ( 1183  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1794 ( 1184  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1795 ( 1185  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1796 ( 1186  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1797 ( 1187  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1798 ( 1188  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1808 ( 1189  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1809 ( 1190  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1810 ( 1191  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1812c ( 1192  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1815 ( 1193  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1816 ( 1194  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1817 ( 1195  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1819c ( 1196  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1820 ( 1197  of  2614 )
## Warning: Removed 262 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1821 ( 1198  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1822 ( 1199  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1823 ( 1200  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1825 ( 1201  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1826 ( 1202  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1827 ( 1203  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1828 ( 1204  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1829 ( 1205  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1830 ( 1206  of  2614 )
## Warning: Removed 133 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1832 ( 1207  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1833c ( 1208  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1835c ( 1209  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1836c ( 1210  of  2614 )
## Warning: Removed 103 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1837c ( 1211  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1838c ( 1212  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1839c ( 1213  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1842c ( 1214  of  2614 )
## Warning: Removed 97 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1843c ( 1215  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1847 ( 1216  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1848 ( 1217  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1850 ( 1218  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1852 ( 1219  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1853 ( 1220  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1854c ( 1221  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1855c ( 1222  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1856c ( 1223  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1860 ( 1224  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1862 ( 1225  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1864c ( 1226  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1865c ( 1227  of  2614 )
## Warning: Removed 121 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1866 ( 1228  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1867 ( 1229  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1868 ( 1230  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1869c ( 1231  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1871c ( 1232  of  2614 )
## Warning: Removed 179 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1872c ( 1233  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1874 ( 1234  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1875 ( 1235  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1876 ( 1236  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1878 ( 1237  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1880c ( 1238  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1881c ( 1239  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1882c ( 1240  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1885c ( 1241  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1886c ( 1242  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1887 ( 1243  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1891 ( 1244  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1893 ( 1245  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1894c ( 1246  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1896c ( 1247  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1899c ( 1248  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1900c ( 1249  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1901 ( 1250  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1904 ( 1251  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1905c ( 1252  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1906c ( 1253  of  2614 )
## Warning: Removed 143 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1908c ( 1254  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1909c ( 1255  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1910c ( 1256  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1912c ( 1257  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1913 ( 1258  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1915 ( 1259  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1919c ( 1260  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1920 ( 1261  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1922 ( 1262  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1923 ( 1263  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1924c ( 1264  of  2614 )
## Warning: Removed 164 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1925 ( 1265  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1926c ( 1266  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1927 ( 1267  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1928c ( 1268  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1929c ( 1269  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1932 ( 1270  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1936 ( 1271  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1938 ( 1272  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1942c ( 1273  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1943c ( 1274  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1944c ( 1275  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1956 ( 1276  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1957 ( 1277  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1960c ( 1278  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1962A ( 1279  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1962c ( 1280  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1963c ( 1281  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1975 ( 1282  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1976c ( 1283  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1977 ( 1284  of  2614 )
## Warning: Removed 127 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1978 ( 1285  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1980c ( 1286  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1981c ( 1287  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1982A ( 1288  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1983 ( 1289  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1984c ( 1290  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1987 ( 1291  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1989c ( 1292  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1990c ( 1293  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1991A ( 1294  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1991c ( 1295  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1992c ( 1296  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1993c ( 1297  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv1996 ( 1298  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2000 ( 1299  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2001 ( 1300  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2002 ( 1301  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2004c ( 1302  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2005c ( 1303  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2006 ( 1304  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2007c ( 1305  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2008c ( 1306  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2010 ( 1307  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2012 ( 1308  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2018 ( 1309  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2019 ( 1310  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2021c ( 1311  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2026c ( 1312  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2027c ( 1313  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2031c ( 1314  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2035 ( 1315  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2037c ( 1316  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2038c ( 1317  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2041c ( 1318  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2042c ( 1319  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2045c ( 1320  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2047c ( 1321  of  2614 )
## Warning: Removed 358 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2048c ( 1322  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2050 ( 1323  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2051c ( 1324  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2052c ( 1325  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2054 ( 1326  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2055c ( 1327  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2061c ( 1328  of  2614 )
## Warning: Removed 169 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2062c ( 1329  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2063A ( 1330  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2064 ( 1331  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2065 ( 1332  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2066 ( 1333  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2067c ( 1334  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2068c ( 1335  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2070c ( 1336  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2071c ( 1337  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2073c ( 1338  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2074 ( 1339  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2080 ( 1340  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2082 ( 1341  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2083 ( 1342  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2089c ( 1343  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2090 ( 1344  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2091c ( 1345  of  2614 )
## Warning: Removed 119 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2092c ( 1346  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2094c ( 1347  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2095c ( 1348  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2096c ( 1349  of  2614 )
## Warning: Removed 145 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2097c ( 1350  of  2614 )
## Warning: Removed 123 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2101 ( 1351  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2102 ( 1352  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2103c ( 1353  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2104c ( 1354  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2109c ( 1355  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2110c ( 1356  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2111c ( 1357  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2112c ( 1358  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2113 ( 1359  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2114 ( 1360  of  2614 )
## Warning: Removed 130 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2115c ( 1361  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2116 ( 1362  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2117 ( 1363  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2118c ( 1364  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2121c ( 1365  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2122c ( 1366  of  2614 )
## Warning: Removed 193 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2124c ( 1367  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2125 ( 1368  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2129c ( 1369  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2130c ( 1370  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2131c ( 1371  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2132 ( 1372  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2134c ( 1373  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2135c ( 1374  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2137c ( 1375  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2138 ( 1376  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2139 ( 1377  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2140c ( 1378  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2141c ( 1379  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2142c ( 1380  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2145c ( 1381  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2147c ( 1382  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2148c ( 1383  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2149c ( 1384  of  2614 )
## Warning: Removed 113 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2150c ( 1385  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2151c ( 1386  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2152c ( 1387  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2153c ( 1388  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2155c ( 1389  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2157c ( 1390  of  2614 )
## Warning: Removed 108 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2158c ( 1391  of  2614 )
## Warning: Removed 114 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2159c ( 1392  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2161c ( 1393  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2162c ( 1394  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2163c ( 1395  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2164c ( 1396  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2165c ( 1397  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2166c ( 1398  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2169c ( 1399  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2170 ( 1400  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2171 ( 1401  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2172c ( 1402  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2173 ( 1403  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2174 ( 1404  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2175c ( 1405  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2176 ( 1406  of  2614 )
## Warning: Removed 160 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2178c ( 1407  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2179c ( 1408  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2182c ( 1409  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2183c ( 1410  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2184c ( 1411  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2185c ( 1412  of  2614 )
## Warning: Removed 122 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2187 ( 1413  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2188c ( 1414  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2190c ( 1415  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2192c ( 1416  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2194 ( 1417  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2195 ( 1418  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2196 ( 1419  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2198c ( 1420  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2200c ( 1421  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2201 ( 1422  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2202c ( 1423  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2203 ( 1424  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2204c ( 1425  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2206 ( 1426  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2207 ( 1427  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2210c ( 1428  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2211c ( 1429  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2212 ( 1430  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2213 ( 1431  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2214c ( 1432  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2215 ( 1433  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2216 ( 1434  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2217 ( 1435  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2218 ( 1436  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2219 ( 1437  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2220 ( 1438  of  2614 )
## Warning: Removed 175 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2221c ( 1439  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2222c ( 1440  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2223c ( 1441  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2224c ( 1442  of  2614 )
## Warning: Removed 117 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2226 ( 1443  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2228c ( 1444  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2229c ( 1445  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2230c ( 1446  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2231c ( 1447  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2232 ( 1448  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2235 ( 1449  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2237 ( 1450  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2237A ( 1451  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2238c ( 1452  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2240c ( 1453  of  2614 )
## Warning: Removed 182 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2241 ( 1454  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2242 ( 1455  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2243 ( 1456  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2244 ( 1457  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2245 ( 1458  of  2614 )
## Warning: Removed 119 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2246 ( 1459  of  2614 )
## Warning: Removed 169 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2247 ( 1460  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2249c ( 1461  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2251 ( 1462  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2252 ( 1463  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2253 ( 1464  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2256c ( 1465  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2257c ( 1466  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2258c ( 1467  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2259 ( 1468  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2260 ( 1469  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2263 ( 1470  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2264c ( 1471  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2271 ( 1472  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2276 ( 1473  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2280 ( 1474  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2282c ( 1475  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2284 ( 1476  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2285 ( 1477  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2287 ( 1478  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2289 ( 1479  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2290 ( 1480  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2291 ( 1481  of  2614 )
## Warning: Removed 104 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2294 ( 1482  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2295 ( 1483  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2296 ( 1484  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2297 ( 1485  of  2614 )
## Warning: Removed 102 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2298 ( 1486  of  2614 )
## Warning: Removed 209 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2299c ( 1487  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2300c ( 1488  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2301 ( 1489  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2302 ( 1490  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2303c ( 1491  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2305 ( 1492  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2307c ( 1493  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2313c ( 1494  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2314c ( 1495  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2315c ( 1496  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2325c ( 1497  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2326c ( 1498  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2327 ( 1499  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2332 ( 1500  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2334 ( 1501  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2336 ( 1502  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2337c ( 1503  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2338c ( 1504  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2339 ( 1505  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2342 ( 1506  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2343c ( 1507  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2344c ( 1508  of  2614 )
## Warning: Removed 179 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2345 ( 1509  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2346c ( 1510  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2349c ( 1511  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2350c ( 1512  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2351c ( 1513  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2352c ( 1514  of  2614 )
## Warning: Removed 130 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2357c ( 1515  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2358 ( 1516  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2359 ( 1517  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2360c ( 1518  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2361c ( 1519  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2363 ( 1520  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2365c ( 1521  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2366c ( 1522  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2368c ( 1523  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2373c ( 1524  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2374c ( 1525  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2375 ( 1526  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2376c ( 1527  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2377c ( 1528  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2378c ( 1529  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2379c ( 1530  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2380c ( 1531  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2382c ( 1532  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2383c ( 1533  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2386c ( 1534  of  2614 )
## Warning: Removed 96 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2391 ( 1535  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2392 ( 1536  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2394 ( 1537  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2397c ( 1538  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2400c ( 1539  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2402 ( 1540  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2403c ( 1541  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2404c ( 1542  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2405 ( 1543  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2406c ( 1544  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2409c ( 1545  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2410c ( 1546  of  2614 )
## Warning: Removed 135 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2411c ( 1547  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2412 ( 1548  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2413c ( 1549  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2416c ( 1550  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2417c ( 1551  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2418c ( 1552  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2419c ( 1553  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2420c ( 1554  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2421c ( 1555  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2423 ( 1556  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2425c ( 1557  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2426c ( 1558  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2427c ( 1559  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2428 ( 1560  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2429 ( 1561  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2430c ( 1562  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2431c ( 1563  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2436 ( 1564  of  2614 )
## Warning: Removed 113 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2438c ( 1565  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2439c ( 1566  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2440c ( 1567  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2441c ( 1568  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2442c ( 1569  of  2614 )
## Warning: Removed 197 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2444c ( 1570  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2445c ( 1571  of  2614 )
## Warning: Removed 127 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2447c ( 1572  of  2614 )
## Warning: Removed 184 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2448c ( 1573  of  2614 )
## Warning: Removed 105 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2449c ( 1574  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2453c ( 1575  of  2614 )
## Warning: Removed 113 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2454c ( 1576  of  2614 )
## Warning: Removed 134 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2455c ( 1577  of  2614 )
## Warning: Removed 133 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2457c ( 1578  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2458 ( 1579  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2460c ( 1580  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2461c ( 1581  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2462c ( 1582  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2463 ( 1583  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2464c ( 1584  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2465c ( 1585  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2466c ( 1586  of  2614 )
## Warning: Removed 106 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2467 ( 1587  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2468c ( 1588  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2470 ( 1589  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2471 ( 1590  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2473 ( 1591  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2474c ( 1592  of  2614 )
## Warning: Removed 377 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2476c ( 1593  of  2614 )
## Warning: Removed 153 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2477c ( 1594  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2482c ( 1595  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2483c ( 1596  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2484c ( 1597  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2486 ( 1598  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2488c ( 1599  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2493 ( 1600  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2495c ( 1601  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2496c ( 1602  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2497c ( 1603  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2498c ( 1604  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2499c ( 1605  of  2614 )
## Warning: Removed 75 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2500c ( 1606  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2501c ( 1607  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2502c ( 1608  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2503c ( 1609  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2504c ( 1610  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2509 ( 1611  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2510c ( 1612  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2511 ( 1613  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2515c ( 1614  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2516c ( 1615  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2518c ( 1616  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2520c ( 1617  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2521 ( 1618  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2522c ( 1619  of  2614 )
## Warning: Removed 830 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2524c ( 1620  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2525c ( 1621  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2526 ( 1622  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2527 ( 1623  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2528c ( 1624  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2529 ( 1625  of  2614 )
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2530A ( 1626  of  2614 )
## Warning: Removed 106 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2531c ( 1627  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2532c ( 1628  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2533c ( 1629  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2534c ( 1630  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2535c ( 1631  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2536 ( 1632  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2538c ( 1633  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2539c ( 1634  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2540c ( 1635  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2548A ( 1636  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2553c ( 1637  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2554c ( 1638  of  2614 )
## Warning: Removed 289 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2555c ( 1639  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2556c ( 1640  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2557 ( 1641  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2558 ( 1642  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2559c ( 1643  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2563 ( 1644  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2564 ( 1645  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2565 ( 1646  of  2614 )
## Warning: Removed 161 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2566 ( 1647  of  2614 )
## Warning: Removed 114 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2567 ( 1648  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2568c ( 1649  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2569c ( 1650  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2570 ( 1651  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2571c ( 1652  of  2614 )
## Warning: Removed 132 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2572c ( 1653  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2573 ( 1654  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2574 ( 1655  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2575 ( 1656  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2576c ( 1657  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2579 ( 1658  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2580c ( 1659  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2581c ( 1660  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2582 ( 1661  of  2614 )
## Warning: Removed 139 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2583c ( 1662  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2584c ( 1663  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2585c ( 1664  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2586c ( 1665  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2587c ( 1666  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2588c ( 1667  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2589 ( 1668  of  2614 )
## Warning: Removed 195 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2590 ( 1669  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2592c ( 1670  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2593c ( 1671  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2595 ( 1672  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2597 ( 1673  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2598 ( 1674  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2601A ( 1675  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2603c ( 1676  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2604c ( 1677  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2605c ( 1678  of  2614 )
## Warning: Removed 133 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2606c ( 1679  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2607 ( 1680  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2609c ( 1681  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2610c ( 1682  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2611c ( 1683  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2612c ( 1684  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2613c ( 1685  of  2614 )
## Warning: Removed 135 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2614c ( 1686  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2616 ( 1687  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2618 ( 1688  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2619c ( 1689  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2622 ( 1690  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2623 ( 1691  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2624c ( 1692  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2626c ( 1693  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2629 ( 1694  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2632c ( 1695  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2633c ( 1696  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2637 ( 1697  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2641 ( 1698  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2643 ( 1699  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2650c ( 1700  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2658c ( 1701  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2664 ( 1702  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2667 ( 1703  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2668 ( 1704  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2670c ( 1705  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2671 ( 1706  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2672 ( 1707  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2673 ( 1708  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2674 ( 1709  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2675c ( 1710  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2676c ( 1711  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2677c ( 1712  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2678c ( 1713  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2679 ( 1714  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2680 ( 1715  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2681 ( 1716  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2682c ( 1717  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2683 ( 1718  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2689c ( 1719  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2690c ( 1720  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2691 ( 1721  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2692 ( 1722  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2694c ( 1723  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2695 ( 1724  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2696c ( 1725  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2697c ( 1726  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2698 ( 1727  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2699c ( 1728  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2700 ( 1729  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2701c ( 1730  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2702 ( 1731  of  2614 )
## Warning: Removed 155 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2703 ( 1732  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2704 ( 1733  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2705c ( 1734  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2708c ( 1735  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2709 ( 1736  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2710 ( 1737  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2711 ( 1738  of  2614 )
## Warning: Removed 79 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2713 ( 1739  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2714 ( 1740  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2715 ( 1741  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2717c ( 1742  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2718c ( 1743  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2720 ( 1744  of  2614 )
## Warning: Removed 116 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2721c ( 1745  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2724c ( 1746  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2725c ( 1747  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2726c ( 1748  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2727c ( 1749  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2728c ( 1750  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2731 ( 1751  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2732c ( 1752  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2733c ( 1753  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2734 ( 1754  of  2614 )
## Warning: Removed 105 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2737c ( 1755  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2738c ( 1756  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2739c ( 1757  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2740 ( 1758  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2743c ( 1759  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2744c ( 1760  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2748c ( 1761  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2749 ( 1762  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2750 ( 1763  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2751 ( 1764  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2752c ( 1765  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2753c ( 1766  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2754c ( 1767  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2756c ( 1768  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2759c ( 1769  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2760c ( 1770  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2763c ( 1771  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2764c ( 1772  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2765 ( 1773  of  2614 )
## Warning: Removed 95 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2766c ( 1774  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2771c ( 1775  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2772c ( 1776  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2773c ( 1777  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2775 ( 1778  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2778c ( 1779  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2780 ( 1780  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2781c ( 1781  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2782c ( 1782  of  2614 )
## Warning: Removed 154 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2783c ( 1783  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2785c ( 1784  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2786c ( 1785  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2788 ( 1786  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2789c ( 1787  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2790c ( 1788  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2793c ( 1789  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2794c ( 1790  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2795c ( 1791  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2796c ( 1792  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2799 ( 1793  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2800 ( 1794  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2801c ( 1795  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2802c ( 1796  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2803 ( 1797  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2808 ( 1798  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2818c ( 1799  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2821c ( 1800  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2824c ( 1801  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2826c ( 1802  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2827c ( 1803  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2829c ( 1804  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2831 ( 1805  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2837c ( 1806  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2838c ( 1807  of  2614 )
## Warning: Removed 175 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2839c ( 1808  of  2614 )
## Warning: Removed 120 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2841c ( 1809  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2842c ( 1810  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2843 ( 1811  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2844 ( 1812  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2845c ( 1813  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2847c ( 1814  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2848c ( 1815  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2849c ( 1816  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2850c ( 1817  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2851c ( 1818  of  2614 )
## Warning: Removed 52 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2852c ( 1819  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2854 ( 1820  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2855 ( 1821  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2857c ( 1822  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2858c ( 1823  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2859c ( 1824  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2860c ( 1825  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2861c ( 1826  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2864c ( 1827  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2865 ( 1828  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2868c ( 1829  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2869c ( 1830  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2870c ( 1831  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2871 ( 1832  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2873 ( 1833  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2875 ( 1834  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2878c ( 1835  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2882c ( 1836  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2883c ( 1837  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2887 ( 1838  of  2614 )
## Warning: Removed 113 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2888c ( 1839  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2889c ( 1840  of  2614 )
## Warning: Removed 128 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2890c ( 1841  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2893 ( 1842  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2895c ( 1843  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2899c ( 1844  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2900c ( 1845  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2901c ( 1846  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2902c ( 1847  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2903c ( 1848  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2904c ( 1849  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2905 ( 1850  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2906c ( 1851  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2907c ( 1852  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2908c ( 1853  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2909c ( 1854  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2911 ( 1855  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2913c ( 1856  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2914c ( 1857  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2915c ( 1858  of  2614 )
## Warning: Removed 97 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2916c ( 1859  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2918c ( 1860  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2919c ( 1861  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2921c ( 1862  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2922A ( 1863  of  2614 )
## Warning: Removed 274 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2922c ( 1864  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2923c ( 1865  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2925c ( 1866  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2926c ( 1867  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2927c ( 1868  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2928 ( 1869  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2930 ( 1870  of  2614 )
## Warning: Removed 225 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2931 ( 1871  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2932 ( 1872  of  2614 )
## Warning: Removed 97 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2933 ( 1873  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2934 ( 1874  of  2614 )
## Warning: Removed 234 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2935 ( 1875  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2936 ( 1876  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2939 ( 1877  of  2614 )
## Warning: Removed 428 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2940c ( 1878  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2941 ( 1879  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2942 ( 1880  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2945c ( 1881  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2946c ( 1882  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2947c ( 1883  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2948c ( 1884  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2949c ( 1885  of  2614 )
## Warning: Removed 110 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2950c ( 1886  of  2614 )
## Warning: Removed 155 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2951c ( 1887  of  2614 )
## Warning: Removed 98 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2952 ( 1888  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2953 ( 1889  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2954c ( 1890  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2955c ( 1891  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2956 ( 1892  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2957 ( 1893  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2958c ( 1894  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2959c ( 1895  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2962c ( 1896  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2965c ( 1897  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2966c ( 1898  of  2614 )
## Warning: Removed 191 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2967c ( 1899  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2969c ( 1900  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2970c ( 1901  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2971 ( 1902  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2975a ( 1903  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2976c ( 1904  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2977c ( 1905  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2980 ( 1906  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2981c ( 1907  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2982c ( 1908  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2984 ( 1909  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2985 ( 1910  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2986c ( 1911  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2987c ( 1912  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2988c ( 1913  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2989 ( 1914  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2991 ( 1915  of  2614 )
## Warning: Removed 151 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2992c ( 1916  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2993c ( 1917  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2995c ( 1918  of  2614 )
## Warning: Removed 96 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2996c ( 1919  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2997 ( 1920  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv2999 ( 1921  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3001c ( 1922  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3002c ( 1923  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3003c ( 1924  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3004 ( 1925  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3005c ( 1926  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3006 ( 1927  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3007c ( 1928  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3009c ( 1929  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3010c ( 1930  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3011c ( 1931  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3012c ( 1932  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3013 ( 1933  of  2614 )
## Warning: Removed 155 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3014c ( 1934  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3015c ( 1935  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3016 ( 1936  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3024c ( 1937  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3025c ( 1938  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3028c ( 1939  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3029c ( 1940  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3031 ( 1941  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3032 ( 1942  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3032A ( 1943  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3033 ( 1944  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3034c ( 1945  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3035 ( 1946  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3036c ( 1947  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3037c ( 1948  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3038c ( 1949  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3039c ( 1950  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3040c ( 1951  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3041c ( 1952  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3042c ( 1953  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3043c ( 1954  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3044 ( 1955  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3045 ( 1956  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3046c ( 1957  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3048c ( 1958  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3049c ( 1959  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3050c ( 1960  of  2614 )
## Warning: Removed 218 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3051c ( 1961  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3052c ( 1962  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3053c ( 1963  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3054c ( 1964  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3055 ( 1965  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3057c ( 1966  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3058c ( 1967  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3059 ( 1968  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3061c ( 1969  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3062 ( 1970  of  2614 )
## Warning: Removed 135 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3068c ( 1971  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3071 ( 1972  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3075c ( 1973  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3077 ( 1974  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3079c ( 1975  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3080c ( 1976  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3081 ( 1977  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3082c ( 1978  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3083 ( 1979  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3084 ( 1980  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3085 ( 1981  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3086 ( 1982  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3087 ( 1983  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3088 ( 1984  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3089 ( 1985  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3090 ( 1986  of  2614 )
## Warning: Removed 90 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3091 ( 1987  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3092c ( 1988  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3093c ( 1989  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3094c ( 1990  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3096 ( 1991  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3099c ( 1992  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3101c ( 1993  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3102c ( 1994  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3104c ( 1995  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3105c ( 1996  of  2614 )
## Warning: Removed 138 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3106 ( 1997  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3107c ( 1998  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3116 ( 1999  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3119 ( 2000  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3120 ( 2001  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3121 ( 2002  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3130c ( 2003  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3132c ( 2004  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3133c ( 2005  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3134c ( 2006  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3136 ( 2007  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3137 ( 2008  of  2614 )
## Warning: Removed 91 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3139 ( 2009  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3140 ( 2010  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3141 ( 2011  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3143 ( 2012  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3144c ( 2013  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3145 ( 2014  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3146 ( 2015  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3147 ( 2016  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3148 ( 2017  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3149 ( 2018  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3150 ( 2019  of  2614 )
## Warning: Removed 183 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3151 ( 2020  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3152 ( 2021  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3153 ( 2022  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3154 ( 2023  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3155 ( 2024  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3156 ( 2025  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3157 ( 2026  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3158 ( 2027  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3160c ( 2028  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3161c ( 2029  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3164c ( 2030  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3167c ( 2031  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3168 ( 2032  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3169 ( 2033  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3170 ( 2034  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3179 ( 2035  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3181c ( 2036  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3189 ( 2037  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3190A ( 2038  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3190c ( 2039  of  2614 )
## Warning: Removed 167 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3193c ( 2040  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3194c ( 2041  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3196A ( 2042  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3197 ( 2043  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3198A ( 2044  of  2614 )
## Warning: Removed 95 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3198c ( 2045  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3200c ( 2046  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3203 ( 2047  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3205c ( 2048  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3206c ( 2049  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3207c ( 2050  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3208 ( 2051  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3208A ( 2052  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3210c ( 2053  of  2614 )
## Warning: Removed 96 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3211 ( 2054  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3212 ( 2055  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3213c ( 2056  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3214 ( 2057  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3215 ( 2058  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3218 ( 2059  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3220c ( 2060  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3221A ( 2061  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3223c ( 2062  of  2614 )
## Warning: Removed 132 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3224 ( 2063  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3225c ( 2064  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3226c ( 2065  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3227 ( 2066  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3228 ( 2067  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3229c ( 2068  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3230c ( 2069  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3231c ( 2070  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3232c ( 2071  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3233c ( 2072  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3234c ( 2073  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3237c ( 2074  of  2614 )
## Warning: Removed 322 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3240c ( 2075  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3241c ( 2076  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3243c ( 2077  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3244c ( 2078  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3245c ( 2079  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3246c ( 2080  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3247c ( 2081  of  2614 )
## Warning: Removed 126 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3248c ( 2082  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3249c ( 2083  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3253c ( 2084  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3254 ( 2085  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3255c ( 2086  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3256c ( 2087  of  2614 )
## Warning: Removed 89 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3257c ( 2088  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3259 ( 2089  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3260c ( 2090  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3261 ( 2091  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3262 ( 2092  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3264c ( 2093  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3265c ( 2094  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3266c ( 2095  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3267 ( 2096  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3268 ( 2097  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3269 ( 2098  of  2614 )
## Warning: Removed 111 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3270 ( 2099  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3271c ( 2100  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3272 ( 2101  of  2614 )
## Warning: Removed 89 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3273 ( 2102  of  2614 )
## Warning: Removed 122 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3274c ( 2103  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3275c ( 2104  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3276c ( 2105  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3278c ( 2106  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3279c ( 2107  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3280 ( 2108  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3281 ( 2109  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3282 ( 2110  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3283 ( 2111  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3284 ( 2112  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3285 ( 2113  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3286c ( 2114  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3287c ( 2115  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3290c ( 2116  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3291c ( 2117  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3292 ( 2118  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3293 ( 2119  of  2614 )
## Warning: Removed 106 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3295 ( 2120  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3296 ( 2121  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3297 ( 2122  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3298c ( 2123  of  2614 )
## Warning: Removed 119 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3299c ( 2124  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3301c ( 2125  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3302c ( 2126  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3303c ( 2127  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3304 ( 2128  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3305c ( 2129  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3306c ( 2130  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3307 ( 2131  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3308 ( 2132  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3309c ( 2133  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3310 ( 2134  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3311 ( 2135  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3312A ( 2136  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3313c ( 2137  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3314c ( 2138  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3315c ( 2139  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3317 ( 2140  of  2614 )
## Warning: Removed 99 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3318 ( 2141  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3319 ( 2142  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3321c ( 2143  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3322c ( 2144  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3329 ( 2145  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3330 ( 2146  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3332 ( 2147  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3336c ( 2148  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3339c ( 2149  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3340 ( 2150  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3341 ( 2151  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3342 ( 2152  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3356c ( 2153  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3357 ( 2154  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3359 ( 2155  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3360 ( 2156  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3362c ( 2157  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3364c ( 2158  of  2614 )
## Warning: Removed 77 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3365c ( 2159  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3368c ( 2160  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3369 ( 2161  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3372 ( 2162  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3373 ( 2163  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3375 ( 2164  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3376 ( 2165  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3377c ( 2166  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3384c ( 2167  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3389c ( 2168  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3390 ( 2169  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3391 ( 2170  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3392c ( 2171  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3393 ( 2172  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3395A ( 2173  of  2614 )
## Warning: Removed 125 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3396c ( 2174  of  2614 )
## Warning: Removed 67 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3399 ( 2175  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3400 ( 2176  of  2614 )
## Warning: Removed 107 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3401 ( 2177  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3404c ( 2178  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3405c ( 2179  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3407 ( 2180  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3408 ( 2181  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3409c ( 2182  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3410c ( 2183  of  2614 )
## Warning: Removed 209 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3411c ( 2184  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3412 ( 2185  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3413c ( 2186  of  2614 )
## Warning: Removed 139 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3417c ( 2187  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3418c ( 2188  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3419c ( 2189  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3422c ( 2190  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3423c ( 2191  of  2614 )
## Warning: Removed 142 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3432c ( 2192  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3433c ( 2193  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3435c ( 2194  of  2614 )
## Warning: Removed 142 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3436c ( 2195  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3437 ( 2196  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3438 ( 2197  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3441c ( 2198  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3442c ( 2199  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3443c ( 2200  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3451 ( 2201  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3452 ( 2202  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3455c ( 2203  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3456c ( 2204  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3457c ( 2205  of  2614 )
## Warning: Removed 108 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3458c ( 2206  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3459c ( 2207  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3460c ( 2208  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3461c ( 2209  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3462c ( 2210  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3463 ( 2211  of  2614 )
## Warning: Removed 112 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3464 ( 2212  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3465 ( 2213  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3472 ( 2214  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3477 ( 2215  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3478 ( 2216  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3479 ( 2217  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3480c ( 2218  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3482c ( 2219  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3483c ( 2220  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3484 ( 2221  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3485c ( 2222  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3487c ( 2223  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3488 ( 2224  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3489 ( 2225  of  2614 )
## Warning: Removed 120 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3490 ( 2226  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3492c ( 2227  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3493c ( 2228  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3494c ( 2229  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3495c ( 2230  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3496c ( 2231  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3497c ( 2232  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3498c ( 2233  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3499c ( 2234  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3500c ( 2235  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3501c ( 2236  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3502c ( 2237  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3503c ( 2238  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3504 ( 2239  of  2614 )
## Warning: Removed 48 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3505 ( 2240  of  2614 )
## Warning: Removed 124 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3509c ( 2241  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3510c ( 2242  of  2614 )
## Warning: Removed 69 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3515c ( 2243  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3516 ( 2244  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3517 ( 2245  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3518c ( 2246  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3519 ( 2247  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3520c ( 2248  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3522 ( 2249  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3523 ( 2250  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3524 ( 2251  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3526 ( 2252  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3528c ( 2253  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3529c ( 2254  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3534c ( 2255  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3535c ( 2256  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3536c ( 2257  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3537 ( 2258  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3540c ( 2259  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3542c ( 2260  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3543c ( 2261  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3544c ( 2262  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3545c ( 2263  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3546 ( 2264  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3547 ( 2265  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3548c ( 2266  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3550 ( 2267  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3554 ( 2268  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3556c ( 2269  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3559c ( 2270  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3560c ( 2271  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3561 ( 2272  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3562 ( 2273  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3564 ( 2274  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3566c ( 2275  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3568c ( 2276  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3569c ( 2277  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3570c ( 2278  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3571 ( 2279  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3572 ( 2280  of  2614 )
## Warning: Removed 44 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3573c ( 2281  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3574 ( 2282  of  2614 )
## Warning: Removed 94 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3575c ( 2283  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3576 ( 2284  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3577 ( 2285  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3579c ( 2286  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3580c ( 2287  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3581c ( 2288  of  2614 )
## Warning: Removed 60 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3582c ( 2289  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3583c ( 2290  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3584 ( 2291  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3586 ( 2292  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3587c ( 2293  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3588c ( 2294  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3589 ( 2295  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3591c ( 2296  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3592 ( 2297  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3593 ( 2298  of  2614 )
## Warning: Removed 307 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3596c ( 2299  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3597c ( 2300  of  2614 )
## Warning: Removed 100 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3598c ( 2301  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3600c ( 2302  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3601c ( 2303  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3602c ( 2304  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3604c ( 2305  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3606c ( 2306  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3607c ( 2307  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3608c ( 2308  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3609c ( 2309  of  2614 )
## Warning: Removed 163 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3610c ( 2310  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3614c ( 2311  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3615c ( 2312  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3616c ( 2313  of  2614 )
## Warning: Removed 28 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3617 ( 2314  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3618 ( 2315  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3623 ( 2316  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3624c ( 2317  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3625c ( 2318  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3626c ( 2319  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3627c ( 2320  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3628 ( 2321  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3631 ( 2322  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3632 ( 2323  of  2614 )
## Warning: Removed 65 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3633 ( 2324  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3634c ( 2325  of  2614 )
## Warning: Removed 55 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3644c ( 2326  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3645 ( 2327  of  2614 )
## Warning: Removed 214 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3646c ( 2328  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3647c ( 2329  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3648c ( 2330  of  2614 )
## Warning: Removed 154 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3651 ( 2331  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3661 ( 2332  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3662c ( 2333  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3663c ( 2334  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3666c ( 2335  of  2614 )
## Warning: Removed 133 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3667 ( 2336  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3669 ( 2337  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3670 ( 2338  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3671c ( 2339  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3672c ( 2340  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3673c ( 2341  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3674c ( 2342  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3675 ( 2343  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3676 ( 2344  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3677c ( 2345  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3678A ( 2346  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3678c ( 2347  of  2614 )
## Warning: Removed 86 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3679 ( 2348  of  2614 )
## Warning: Removed 135 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3680 ( 2349  of  2614 )
## Warning: Removed 161 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3682 ( 2350  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3683 ( 2351  of  2614 )
## Warning: Removed 83 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3684 ( 2352  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3685c ( 2353  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3687c ( 2354  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3688c ( 2355  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3690 ( 2356  of  2614 )
## Warning: Removed 36 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3691 ( 2357  of  2614 )
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3692 ( 2358  of  2614 )
## Warning: Removed 76 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3693 ( 2359  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3695 ( 2360  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3696c ( 2361  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3697A ( 2362  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3699 ( 2363  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3700c ( 2364  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3701c ( 2365  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3702c ( 2366  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3703c ( 2367  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3705c ( 2368  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3708c ( 2369  of  2614 )
## Warning: Removed 129 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3709c ( 2370  of  2614 )
## Warning: Removed 109 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3710 ( 2371  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3713 ( 2372  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3715c ( 2373  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3716c ( 2374  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3717 ( 2375  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3718c ( 2376  of  2614 )
## Warning: Removed 105 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3719 ( 2377  of  2614 )
## Warning: Removed 115 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3720 ( 2378  of  2614 )
## Warning: Removed 148 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3721c ( 2379  of  2614 )
## Warning: Removed 49 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3722c ( 2380  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3723 ( 2381  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3726 ( 2382  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3729 ( 2383  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3730c ( 2384  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3731 ( 2385  of  2614 )
## Warning: Removed 62 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3732 ( 2386  of  2614 )
## Warning: Removed 169 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3734c ( 2387  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3736 ( 2388  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3737 ( 2389  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3744 ( 2390  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3747 ( 2391  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3753c ( 2392  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3754 ( 2393  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3755c ( 2394  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3758c ( 2395  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3759c ( 2396  of  2614 )
## Warning: Removed 127 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3761c ( 2397  of  2614 )
## Warning: Removed 43 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3762c ( 2398  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3763 ( 2399  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3764c ( 2400  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3765c ( 2401  of  2614 )
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3766 ( 2402  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3767c ( 2403  of  2614 )
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3768 ( 2404  of  2614 )
## Warning: Removed 68 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3772 ( 2405  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3773c ( 2406  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3774 ( 2407  of  2614 )
## Warning: Removed 137 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3775 ( 2408  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3777 ( 2409  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3778c ( 2410  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3779 ( 2411  of  2614 )
## Warning: Removed 40 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3780 ( 2412  of  2614 )
## Warning: Removed 56 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3781 ( 2413  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3782 ( 2414  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3784 ( 2415  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3786c ( 2416  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3787c ( 2417  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3788 ( 2418  of  2614 )
## Warning: Removed 78 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3790 ( 2419  of  2614 )
## Warning: Removed 74 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3791 ( 2420  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3792 ( 2421  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3793 ( 2422  of  2614 )
## Warning: Removed 64 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3794 ( 2423  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3795 ( 2424  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3796 ( 2425  of  2614 )
## Warning: Removed 88 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3797 ( 2426  of  2614 )
## Warning: Removed 58 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3799c ( 2427  of  2614 )
## Warning: Removed 341 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3800c ( 2428  of  2614 )
## Warning: Removed 227 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3801c ( 2429  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3802c ( 2430  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3803c ( 2431  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3804c ( 2432  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3805c ( 2433  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3806c ( 2434  of  2614 )
## Warning: Removed 96 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3808c ( 2435  of  2614 )
## Warning: Removed 61 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3809c ( 2436  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3813c ( 2437  of  2614 )
## Warning: Removed 93 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3814c ( 2438  of  2614 )
## Warning: Removed 37 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3815c ( 2439  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3816c ( 2440  of  2614 )
## Warning: Removed 47 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3817 ( 2441  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3818 ( 2442  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3819 ( 2443  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3820c ( 2444  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3822 ( 2445  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3824c ( 2446  of  2614 )
## Warning: Removed 374 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3825c ( 2447  of  2614 )
## Warning: Removed 51 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3826 ( 2448  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3834c ( 2449  of  2614 )
## Warning: Removed 38 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3835 ( 2450  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3836 ( 2451  of  2614 )
## Warning: Removed 41 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3837c ( 2452  of  2614 )
## Warning: Removed 70 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3838c ( 2453  of  2614 )
## Warning: Removed 45 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3841 ( 2454  of  2614 )
## Warning: Removed 72 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3842c ( 2455  of  2614 )
## Warning: Removed 30 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3843c ( 2456  of  2614 )
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3846 ( 2457  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3849 ( 2458  of  2614 )
## Warning: Removed 59 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3850 ( 2459  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3852 ( 2460  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3853 ( 2461  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3854c ( 2462  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3855 ( 2463  of  2614 )
## Warning: Removed 66 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3856c ( 2464  of  2614 )
## Warning: Removed 87 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3858c ( 2465  of  2614 )
## Warning: Removed 327 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3859c ( 2466  of  2614 )
## Warning: Removed 19 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3860 ( 2467  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3863 ( 2468  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3864 ( 2469  of  2614 )
## Warning: Removed 29 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3865 ( 2470  of  2614 )
## Warning: Removed 46 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3866 ( 2471  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3867 ( 2472  of  2614 )
## Warning: Removed 135 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3868 ( 2473  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3869 ( 2474  of  2614 )
## Warning: Removed 101 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3870 ( 2475  of  2614 )
## Warning: Removed 130 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3871 ( 2476  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3872 ( 2477  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3873 ( 2478  of  2614 )
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3874 ( 2479  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3875 ( 2480  of  2614 )
## Warning: Removed 92 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3876 ( 2481  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3878 ( 2482  of  2614 )
## Warning: Removed 82 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3879c ( 2483  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3880c ( 2484  of  2614 )
## Warning: Removed 63 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3881c ( 2485  of  2614 )
## Warning: Removed 27 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3882c ( 2486  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3883c ( 2487  of  2614 )
## Warning: Removed 21 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3884c ( 2488  of  2614 )
## Warning: Removed 73 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3885c ( 2489  of  2614 )
## Warning: Removed 22 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3886c ( 2490  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3887c ( 2491  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3888c ( 2492  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3890c ( 2493  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3891c ( 2494  of  2614 )
## Warning: Removed 98 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3894c ( 2495  of  2614 )
## Warning: Removed 57 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3895c ( 2496  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3902c ( 2497  of  2614 )
## Warning: Removed 84 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3907c ( 2498  of  2614 )
## Warning: Removed 50 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3908 ( 2499  of  2614 )
## Warning: Removed 112 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3909 ( 2500  of  2614 )
## Warning: Removed 154 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3910 ( 2501  of  2614 )
## Warning: Removed 71 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3913 ( 2502  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3914 ( 2503  of  2614 )
## Warning: Removed 85 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3915 ( 2504  of  2614 )
## Warning: Removed 34 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3916c ( 2505  of  2614 )
## Warning: Removed 144 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3917c ( 2506  of  2614 )
## Warning: Removed 53 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3918c ( 2507  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3919c ( 2508  of  2614 )
## Warning: Removed 80 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3920c ( 2509  of  2614 )
## Warning: Removed 33 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3921c ( 2510  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3922c ( 2511  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3923c ( 2512  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  1/Rv3924c ( 2513  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0073/Rv2564 ( 2514  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0107c/Rv1415 ( 2515  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0327c/Rv3240c ( 2516  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0386/Rv0890c ( 2517  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0469/Rv0645c ( 2518  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0593/Rv0173 ( 2519  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0645c/Rv0469 ( 2520  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv0893c/Rv0281 ( 2521  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1039c/Rv0387c ( 2522  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1135c/Rv0878c ( 2523  of  2614 )
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1181/Rv2940c ( 2524  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1253/Rv3366 ( 2525  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1281c/Rv2713 ( 2526  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1320c/Rv1318c ( 2527  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1361c/Rv1196 ( 2528  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1467c/Rv0244c ( 2529  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1526c/Rv1524 ( 2530  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1529/Rv1521 ( 2531  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1630/Rv1564c ( 2532  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1661/Rv2048c ( 2533  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1662/Rv2048c ( 2534  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1674c/Rv3295 ( 2535  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1695/Rv3285 ( 2536  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1729c/Rv0725c ( 2537  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1736c/Rv1161 ( 2538  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1736c/Rv1164 ( 2539  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1760/Rv1595 ( 2540  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1771/Rv0706 ( 2541  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1797/Rv0667 ( 2542  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1821/Rv3240c ( 2543  of  2614 )
## Warning: Removed 54 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv1945/Rv1148c ( 2544  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2048c/Rv1661 ( 2545  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2115c/Rv0435c ( 2546  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2223c/Rv2224c ( 2547  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2284/Rv1426c ( 2548  of  2614 )
## Drew the Quality Contol plot(boxplot) for  2/Rv2346c/Rv1793 ( 2549  of  2614 )
## Warning: Removed 16 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2351c/Rv2350c ( 2550  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2564/Rv0073 ( 2551  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2590/Rv0101 ( 2552  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2643/Rv3120 ( 2553  of  2614 )
## Warning: Removed 26 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2650c/Rv1576c ( 2554  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2703/Rv2710 ( 2555  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2828c/Rv2825c ( 2556  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2931/Rv2932 ( 2557  of  2614 )
## Warning: Removed 23 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2932/Rv2931 ( 2558  of  2614 )
## Warning: Removed 17 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2933/Rv2932 ( 2559  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2940c/Rv1181 ( 2560  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2940c/Rv1527c ( 2561  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2947c/Rv2048c ( 2562  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2949c/Rv3436c ( 2563  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2953/Rv2449c ( 2564  of  2614 )
## Warning: Removed 18 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2956/Rv1513 ( 2565  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2962c/Rv3596c ( 2566  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv2974c/Rv1213 ( 2567  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3022A/Rv0285 ( 2568  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3034c/Rv0777 ( 2569  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3049c/Rv0892 ( 2570  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3083/Rv0565c ( 2571  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3083/Rv3854c ( 2572  of  2614 )
## Warning: Removed 42 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3117/Rv0815c ( 2573  of  2614 )
## Warning: Removed 24 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3118/Rv0814c ( 2574  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3132c/Rv2027c ( 2575  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3182/Rv2022c ( 2576  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3375/Rv2838c ( 2577  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3392c/Rv0470c ( 2578  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3392c/Rv0642c ( 2579  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3399/Rv0145 ( 2580  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3417c/Rv0440 ( 2581  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3478/Rv1361c ( 2582  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3480c/Rv2285 ( 2583  of  2614 )
## Warning: Removed 35 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3515c/Rv3513c ( 2584  of  2614 )
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3533c/Rv3159c ( 2585  of  2614 )
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3596c/Rv0384c ( 2586  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3692/Rv1479 ( 2587  of  2614 )
## Warning: Removed 9 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3767c/Rv1729c ( 2588  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3804c/Rv1886c ( 2589  of  2614 )
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3825c/Rv1181 ( 2590  of  2614 )
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3825c/Rv1527c ( 2591  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3826/Rv2941 ( 2592  of  2614 )
## Warning: Removed 2 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  2/Rv3833/Rv1925 ( 2593  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv0644c/Rv0643c/Rv0470c ( 2594  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv0748/Rv0277A/Rv3393 ( 2595  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv1131/Rv0896/Rv0889c ( 2596  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv1320c/Rv1319c/Rv1318c ( 2597  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv1361c/Rv1196/Rv3478 ( 2598  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv1529/Rv1521/Rv2930 ( 2599  of  2614 )
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv2015c/Rv1765c/Rv3031 ( 2600  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv2351c/Rv2350c/Rv2349c ( 2601  of  2614 )
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv2933/Rv2932/Rv2931 ( 2602  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv2941/Rv1529/Rv1521 ( 2603  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3121/Rv2266/Rv0212c ( 2604  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3392c/Rv0503c/Rv0470c ( 2605  of  2614 )
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3392c/Rv0644c/Rv0643c ( 2606  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3767c/Rv0726c/Rv0146 ( 2607  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3798/Rv1313c/Rv2984 ( 2608  of  2614 )
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  3/Rv3825c/Rv2940c/Rv1181 ( 2609  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  4/Rv2932/Rv2931/Rv2823c/Rv3566c ( 2610  of  2614 )
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  4/Rv3140/Rv1297/Rv0549c/Rv2308 ( 2611  of  2614 )
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  4/Rv3826/Rv2941/Rv1529/Rv1521 ( 2612  of  2614 )
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  5/Rv3619c/Rv2346c/Rv1793/Rv1198/Rv1037c ( 2613  of  2614 )
## Warning: Removed 95 rows containing non-finite values (stat_boxplot).
## Drew the Quality Contol plot(boxplot) for  5/Rv3620c/Rv2347c/Rv1792/Rv1197/Rv1038c ( 2614  of  2614 )
my_levels <- levels(as.factor(msstats_input$condition))
my_levels
## [1] "comp_cf"     "comp_whole"  "delta_cf"    "delta_whole"
comparison <- ghetto_contrast_matrix(c("delta_whole", "delta_cf"),
                                     c("comp_whole", "comp_cf"))
first_comparison <- t(as.matrix(comparison[1, ]))
rownames(first_comparison) <- "whole"
first_msstats_comparison <- MSstats::groupComparison(contrast.matrix=first_comparison,
                                                     data=msstats_quant)
## 2018-05-16 17:55:34 INFO::MSstats - starting groupComparison().
## 2018-05-16 17:55:34 INFO::Some important variables: labeled=FALSE scopeOfBioReplication=expanded
## 2018-05-16 17:55:34 INFO::Case control design of experiment is acceptable.
## 2018-05-16 17:55:34 INFO::Starting inference methods.
## 
  |                                                                       
  |                                                                 |   0%2018-05-16 17:55:34 INFO::Testing a comparison of protein: 1/DECOY_Rv3047c_UNMAPPED(1 of 2614)
## 2018-05-16 17:55:34 INFO::Fitting a single group.
## 2018-05-16 17:55:34 WARNING::Results of protein 1/DECOY_Rv3047c_UNMAPPED for comparison whole
## 2018-05-16 17:55:34 INFO::Testing a comparison of protein: 1/Rv0001(2 of 2614)
## 2018-05-16 17:55:34 WARNING::Results of protein 1/Rv0001 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:34 INFO::Testing a comparison of protein: 1/Rv0002(3 of 2614)
## 2018-05-16 17:55:34 INFO::Testing a comparison of protein: 1/Rv0003(4 of 2614)
## 2018-05-16 17:55:34 WARNING::Results of protein 1/Rv0003 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0005(5 of 2614)
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0006(6 of 2614)
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0007(7 of 2614)
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0008c(8 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0008c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0009(9 of 2614)
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0010c(10 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0010c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0011c(11 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0011c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0012(12 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0012 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0014c(13 of 2614)
## 
  |                                                                       
  |                                                                 |   1%2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0015c(14 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0015c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0016c(15 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0016c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0017c(16 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0017c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0018c(17 of 2614)
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0019c(18 of 2614)
## 2018-05-16 17:55:35 WARNING::Results of protein 1/Rv0019c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:35 INFO::Testing a comparison of protein: 1/Rv0020c(19 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0023(20 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0023 for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |=                                                                |   1%2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0025(21 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0025 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0027(22 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0027 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0029(23 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0029 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0032(24 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0032 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0034(25 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0034 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0035(26 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0035 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0036c(27 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0037c(28 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0037c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0038(29 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0038 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0040c(30 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0041(31 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0042c(32 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0043c(33 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0043c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0044c(34 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0044c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0045c(35 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0045c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0046c(36 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0047c(37 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0047c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0048c(38 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0050(39 of 2614)
## 
  |                                                                       
  |=                                                                |   2%2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0051(40 of 2614)
## 2018-05-16 17:55:36 WARNING::Results of protein 1/Rv0051 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0052(41 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0053(42 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0054(43 of 2614)
## 2018-05-16 17:55:36 INFO::Testing a comparison of protein: 1/Rv0055(44 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0056(45 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0058(46 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0058 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0059(47 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0059 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0060(48 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0060 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0061c(49 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0062(50 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0063(51 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0066c(52 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0068(53 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0068 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0069c(54 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0069c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0070c(55 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0070c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0072(56 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0072 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0073(57 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0073 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0074(58 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0075(59 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0077c(60 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0077c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==                                                               |   2%2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0078(61 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0078A(62 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0079(63 of 2614)
## 2018-05-16 17:55:37 INFO::Fitting a single group.
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0079 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0081(64 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0087(65 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0087 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==                                                               |   3%2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0088(66 of 2614)
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0091(67 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0091 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0092(68 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0092 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0097(69 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0097 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:37 INFO::Testing a comparison of protein: 1/Rv0098(70 of 2614)
## 2018-05-16 17:55:37 WARNING::Results of protein 1/Rv0098 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0099(71 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0099 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0101(72 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0101 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0103c(73 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0103c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0107c(74 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0107c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0108c(75 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0116c(76 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0117(77 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0117 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0118c(78 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0118c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0119(79 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0119 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0120c(80 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0121c(81 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0121c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0123(82 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0123 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0125(83 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0126(84 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0127(85 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0129c(86 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0130(87 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0130 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0131c(88 of 2614)
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0134(89 of 2614)
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0134 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:38 INFO::Testing a comparison of protein: 1/Rv0135c(90 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:38 WARNING::Results of protein 1/Rv0135c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0136(91 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0136 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==                                                               |   4%2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0137c(92 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0138(93 of 2614)
## 2018-05-16 17:55:39 INFO::Fitting a single group.
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0138 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0139(94 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0139 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0140(95 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0141c(96 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0144(97 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0145(98 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0145 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0146(99 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0146 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0147(100 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0147 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===                                                              |   4%2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0148(101 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0149(102 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0149 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0153c(103 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0153c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0154c(104 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0155(105 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0157(106 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0157 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0157A(107 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0158(108 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0161(109 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0162c(110 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0162c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0163(111 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0164(112 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0166(113 of 2614)
## 2018-05-16 17:55:39 WARNING::Results of protein 1/Rv0166 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0169(114 of 2614)
## 2018-05-16 17:55:39 INFO::Testing a comparison of protein: 1/Rv0170(115 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0171(116 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0172(117 of 2614)
## 
  |                                                                       
  |===                                                              |   5%2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0173(118 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0174(119 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0175(120 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0176(121 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0176 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0177(122 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0177 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0178(123 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0179c(124 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0180c(125 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0180c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0181c(126 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0181c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0182c(127 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0182c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0183(128 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0184(129 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0184 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0185(130 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0185 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0186(131 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0186A(132 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0187(133 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0189c(134 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0190(135 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0190 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0196(136 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0196 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0198c(137 of 2614)
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0199(138 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0199 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0200(139 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0200 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0201c(140 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0201c for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |====                                                             |   5%2018-05-16 17:55:40 INFO::Testing a comparison of protein: 1/Rv0202c(141 of 2614)
## 2018-05-16 17:55:40 WARNING::Results of protein 1/Rv0202c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0203(142 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0204c(143 of 2614)
## 2018-05-16 17:55:41 INFO::Fitting a single group.
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0204c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |====                                                             |   6%2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0206c(144 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0207c(145 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0207c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0208c(146 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0211(147 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0214(148 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0214 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0215c(149 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0215c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0216(150 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0217c(151 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0217c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0220(152 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0220 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0221(153 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0221 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0222(154 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0223c(155 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0223c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0226c(156 of 2614)
## 2018-05-16 17:55:41 INFO::Fitting a single group.
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0226c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0227c(157 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0229c(158 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0230c(159 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0231(160 of 2614)
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0232(161 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0232 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:41 INFO::Testing a comparison of protein: 1/Rv0233(162 of 2614)
## 2018-05-16 17:55:41 WARNING::Results of protein 1/Rv0233 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0234c(163 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0237(164 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0238(165 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0238 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0239(166 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0239 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0241c(167 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0241c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0242c(168 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0243(169 of 2614)
## 
  |                                                                       
  |====                                                             |   7%2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0244c(170 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0245(171 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0245 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0247c(172 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0248c(173 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0249c(174 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0249c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0250c(175 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0255c(176 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0255c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0256c(177 of 2614)
## 2018-05-16 17:55:42 INFO::Fitting a single group.
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0256c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0262c(178 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0262c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0263c(179 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0263c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0265c(180 of 2614)
## 
  |                                                                       
  |=====                                                            |   7%2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0266c(181 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0266c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0269c(182 of 2614)
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0269c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0270(183 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0271c(184 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0272c(185 of 2614)
## 2018-05-16 17:55:42 INFO::Testing a comparison of protein: 1/Rv0274(186 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:42 WARNING::Results of protein 1/Rv0274 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0276(187 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0276 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0281(188 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0282(189 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0282 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0283(190 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0284(191 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0284 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0285(192 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0286(193 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0287(194 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0288(195 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0289(196 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0289 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=====                                                            |   8%2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0290(197 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0290 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0291(198 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0292(199 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0292 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0293c(200 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0293c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0294(201 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0294 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0295c(202 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0295c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0296c(203 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0298(204 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0300(205 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0300 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0301(206 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0303(207 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0303 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0307c(208 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0307c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0308(209 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0308 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0309(210 of 2614)
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0310c(211 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0310c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:43 INFO::Testing a comparison of protein: 1/Rv0311(212 of 2614)
## 2018-05-16 17:55:43 WARNING::Results of protein 1/Rv0311 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0312(213 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0312 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0313(214 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0315(215 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0316(216 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0317c(217 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0317c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0321(218 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0321 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0324(219 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0324 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0328(220 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0328 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0329c(221 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0329c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======                                                           |   8%2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0331(222 of 2614)
## 
  |                                                                       
  |======                                                           |   9%2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0332(223 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0333(224 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0334(225 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0334 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0337c(226 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0337c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0338c(227 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0338c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0339c(228 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0339c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0340(229 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0341(230 of 2614)
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0342(231 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0342 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:44 INFO::Testing a comparison of protein: 1/Rv0343(232 of 2614)
## 2018-05-16 17:55:44 WARNING::Results of protein 1/Rv0343 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0344c(233 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0347(234 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0348(235 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0349(236 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0349 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0350(237 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0351(238 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0352(239 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0353(240 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0353 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0356c(241 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0357c(242 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0360c(243 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0361(244 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0363c(245 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0365c(246 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0365c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0367c(247 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0367c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0376c(248 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0376c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======                                                           |  10%2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0379(249 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0382c(250 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0382c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0383c(251 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0383c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0384c(252 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0386(253 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0386 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0389(254 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0390(255 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0391(256 of 2614)
## 2018-05-16 17:55:45 INFO::Testing a comparison of protein: 1/Rv0392c(257 of 2614)
## 2018-05-16 17:55:45 WARNING::Results of protein 1/Rv0392c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0394c(258 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0394c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0397A(259 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0398c(260 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0400c(261 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0400c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=======                                                          |  10%2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0404(262 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0404 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0405(263 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0405 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0406c(264 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0406c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0407(265 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0407 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0408(266 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0409(267 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0409 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0410c(268 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0410c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0411c(269 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0412c(270 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0412c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0413(271 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0413 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0414c(272 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0414c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0415(273 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0415 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0417(274 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0417 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=======                                                          |  11%2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0418(275 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0419(276 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0419 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0421c(277 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0422c(278 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0422c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0423c(279 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0424c(280 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0424c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0425c(281 of 2614)
## 2018-05-16 17:55:46 WARNING::Results of protein 1/Rv0425c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0426c(282 of 2614)
## 2018-05-16 17:55:46 INFO::Testing a comparison of protein: 1/Rv0427c(283 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0428c(284 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0428c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0430(285 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0430 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0431(286 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0432(287 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0432 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0433(288 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0433 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0434(289 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0434 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0435c(290 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0435c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0436c(291 of 2614)
## 2018-05-16 17:55:47 INFO::Fitting a single group.
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0436c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0437c(292 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0437c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0438c(293 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0438c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0439c(294 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0439c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0440(295 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0441c(296 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0442c(297 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0443(298 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0444c(299 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0445c(300 of 2614)
## 
  |                                                                       
  |=======                                                          |  12%2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0450c(301 of 2614)
## 
  |                                                                       
  |========                                                         |  12%2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0455c(302 of 2614)
## 2018-05-16 17:55:47 INFO::Testing a comparison of protein: 1/Rv0456c(303 of 2614)
## 2018-05-16 17:55:47 WARNING::Results of protein 1/Rv0456c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0457c(304 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0458(305 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0459(306 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0459 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0461(307 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0461 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0462(308 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0464c(309 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0464c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0466(310 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0467(311 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0468(312 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0469(313 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0469 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0470c(314 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0470c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0472c(315 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0472c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0473(316 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0473 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0474(317 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0474 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0475(318 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0477(319 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0478(320 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0479c(321 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0479c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0480c(322 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0480c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0481c(323 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0481c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0482(324 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0482 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0483(325 of 2614)
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0484c(326 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0484c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |========                                                         |  13%2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0485(327 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0485 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:48 INFO::Testing a comparison of protein: 1/Rv0486(328 of 2614)
## 2018-05-16 17:55:48 WARNING::Results of protein 1/Rv0486 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0487(329 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0487 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0489(330 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0490(331 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0490 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0491(332 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0492c(333 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0492c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0493c(334 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0493c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0495c(335 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0495c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0496(336 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0496 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0497(337 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0498(338 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0498 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0499(339 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0499 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0500(340 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0500A(341 of 2614)
## 
  |                                                                       
  |=========                                                        |  13%2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0501(342 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0501 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0502(343 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0502 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0503c(344 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0504c(345 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0504c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0505c(346 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0505c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0508(347 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0509(348 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0509 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0510(349 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0511(350 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0512(351 of 2614)
## 2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0513(352 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0513 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========                                                        |  14%2018-05-16 17:55:49 INFO::Testing a comparison of protein: 1/Rv0516c(353 of 2614)
## 2018-05-16 17:55:49 WARNING::Results of protein 1/Rv0516c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0517(354 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0517 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0518(355 of 2614)
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0519c(356 of 2614)
## 2018-05-16 17:55:50 INFO::Fitting a single group.
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0519c for comparison whole
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0523c(357 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0523c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0524(358 of 2614)
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0525(359 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0525 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0526(360 of 2614)
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0528(361 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0528 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0529(362 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0529 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0530(363 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0530 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0530A(364 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0530A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0531(365 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0531 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0533c(366 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0533c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0536(367 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0536 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0537c(368 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0537c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0538(369 of 2614)
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0539(370 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0539 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0540(371 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0540 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0542c(372 of 2614)
## 2018-05-16 17:55:50 INFO::Fitting a single group.
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0542c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:50 INFO::Testing a comparison of protein: 1/Rv0543c(373 of 2614)
## 2018-05-16 17:55:50 WARNING::Results of protein 1/Rv0543c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0544c(374 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0544c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0545c(375 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0545c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0546c(376 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0547c(377 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0547c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0548c(378 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0550c(379 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0550c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========                                                        |  15%2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0551c(380 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0551c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0552(381 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0553(382 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0553 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==========                                                       |  15%2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0554(383 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0555(384 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0556(385 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0556 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0558(386 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0558 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0559c(387 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0560c(388 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0560c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0561c(389 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0561c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0562(390 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0562 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0563(391 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0563 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0564c(392 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0564c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0565c(393 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0565c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0566c(394 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0567(395 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0567 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0568(396 of 2614)
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0568 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0569(397 of 2614)
## 2018-05-16 17:55:51 INFO::Testing a comparison of protein: 1/Rv0571c(398 of 2614)
## 2018-05-16 17:55:51 INFO::Fitting a single group.
## 2018-05-16 17:55:51 WARNING::Results of protein 1/Rv0571c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0576(399 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0577(400 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0578c(401 of 2614)
## 2018-05-16 17:55:52 INFO::Fitting a single group.
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0578c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0580c(402 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0580c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0581(403 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0581 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0582(404 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0583c(405 of 2614)
## 
  |                                                                       
  |==========                                                       |  16%2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0586(406 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0586 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0595c(407 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0595c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0596c(408 of 2614)
## 2018-05-16 17:55:52 INFO::Fitting a single group.
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0596c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0597c(409 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0597c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0598c(410 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0599c(411 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0604(412 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0604 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0609(413 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0609 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0610c(414 of 2614)
## 2018-05-16 17:55:52 INFO::Fitting a single group.
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0610c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0613c(415 of 2614)
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0616A(416 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0616A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0617(417 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0617 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0623(418 of 2614)
## 2018-05-16 17:55:52 INFO::Fitting a single group.
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0623 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0626(419 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0626 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0628c(420 of 2614)
## 2018-05-16 17:55:52 INFO::Fitting a single group.
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0628c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0629c(421 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0629c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0630c(422 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0630c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===========                                                      |  16%2018-05-16 17:55:52 INFO::Testing a comparison of protein: 1/Rv0631c(423 of 2614)
## 2018-05-16 17:55:52 WARNING::Results of protein 1/Rv0631c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0632c(424 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0633c(425 of 2614)
## 2018-05-16 17:55:53 WARNING::Results of protein 1/Rv0633c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0634A(426 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0634B(427 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0634c(428 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0635(429 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0636(430 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0637(431 of 2614)
## 2018-05-16 17:55:53 WARNING::Results of protein 1/Rv0637 for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |===========                                                      |  17%2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0638(432 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0639(433 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0640(434 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0641(435 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0642c(436 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0643c(437 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0644c(438 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0645c(439 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0646c(440 of 2614)
## 2018-05-16 17:55:53 WARNING::Results of protein 1/Rv0646c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0647c(441 of 2614)
## 2018-05-16 17:55:53 WARNING::Results of protein 1/Rv0647c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0651(442 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0652(443 of 2614)
## 2018-05-16 17:55:53 INFO::Testing a comparison of protein: 1/Rv0653c(444 of 2614)
## 2018-05-16 17:55:53 INFO::Fitting a single group.
## 2018-05-16 17:55:53 WARNING::Results of protein 1/Rv0653c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0654(445 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0654 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0655(446 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0660c(447 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0667(448 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0668(449 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0669c(450 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0669c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0670(451 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0671(452 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0672(453 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0673(454 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0673 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0675(455 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0675 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0676c(456 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0677c(457 of 2614)
## 
  |                                                                       
  |===========                                                      |  18%2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0678(458 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0679c(459 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0680c(460 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0681(461 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0682(462 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0682 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |============                                                     |  18%2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0683(463 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0684(464 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0685(465 of 2614)
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0686(466 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0686 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0687(467 of 2614)
## 2018-05-16 17:55:54 WARNING::Results of protein 1/Rv0687 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:54 INFO::Testing a comparison of protein: 1/Rv0688(468 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0690c(469 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0690c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0694(470 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0694 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0695(471 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0695 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0696(472 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0696 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0700(473 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0701(474 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0702(475 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0703(476 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0703 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0704(477 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0705(478 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0706(479 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0706 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0707(480 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0708(481 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0709(482 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0710(483 of 2614)
## 
  |                                                                       
  |============                                                     |  19%2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0711(484 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0711 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0712(485 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0712 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0714(486 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0714 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0715(487 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0716(488 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0717(489 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0717 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0718(490 of 2614)
## 2018-05-16 17:55:55 WARNING::Results of protein 1/Rv0718 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0719(491 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0720(492 of 2614)
## 2018-05-16 17:55:55 INFO::Testing a comparison of protein: 1/Rv0721(493 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0722(494 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0722 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0723(495 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0724(496 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0724 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0726c(497 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0726c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0729(498 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0729 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0730(499 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0731c(500 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0732(501 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0732 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0733(502 of 2614)
## 
  |                                                                       
  |=============                                                    |  19%2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0734(503 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0734 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0736(504 of 2614)
## 2018-05-16 17:55:56 INFO::Fitting a single group.
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0736 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0737(505 of 2614)
## 2018-05-16 17:55:56 INFO::Fitting a single group.
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0737 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0738(506 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0740(507 of 2614)
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0743c(508 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0743c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0744c(509 of 2614)
## 2018-05-16 17:55:56 INFO::Fitting a single group.
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0744c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============                                                    |  20%2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0748(510 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0748 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0751c(511 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0751c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0752c(512 of 2614)
## 2018-05-16 17:55:56 WARNING::Results of protein 1/Rv0752c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:56 INFO::Testing a comparison of protein: 1/Rv0753c(513 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0757(514 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0757 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0758(515 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0758 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0759c(516 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0759c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0760c(517 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0761c(518 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0763c(519 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0763c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0764c(520 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0764c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0765c(521 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0765c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0766c(522 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0766c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0767c(523 of 2614)
## 2018-05-16 17:55:57 INFO::Fitting a single group.
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0767c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0768(524 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0768 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0769(525 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0769 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0770(526 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0770 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0772(527 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0772 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0773c(528 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0774c(529 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0777(530 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0778(531 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0780(532 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0780 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0785(533 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0785 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0786c(534 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0787A(535 of 2614)
## 
  |                                                                       
  |=============                                                    |  21%2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0788(536 of 2614)
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0790c(537 of 2614)
## 2018-05-16 17:55:57 INFO::Fitting a single group.
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0790c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:57 INFO::Testing a comparison of protein: 1/Rv0791c(538 of 2614)
## 2018-05-16 17:55:57 WARNING::Results of protein 1/Rv0791c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0794c(539 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0798c(540 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0799c(541 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0800(542 of 2614)
## 
  |                                                                       
  |==============                                                   |  21%2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0801(543 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0802c(544 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0802c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0803(545 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0805(546 of 2614)
## 2018-05-16 17:55:58 INFO::Fitting a single group.
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0805 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0806c(547 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0806c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0807(548 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0807 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0808(549 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0808 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0809(550 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0809 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0810c(551 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0811c(552 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0812(553 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0812 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0813c(554 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0817c(555 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0818(556 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0818 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0819(557 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0819 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0820(558 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0820 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0821c(559 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0821c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0822c(560 of 2614)
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0823c(561 of 2614)
## 2018-05-16 17:55:58 WARNING::Results of protein 1/Rv0823c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:58 INFO::Testing a comparison of protein: 1/Rv0824c(562 of 2614)
## 
  |                                                                       
  |==============                                                   |  22%2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0825c(563 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0825c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0827c(564 of 2614)
## 2018-05-16 17:55:59 INFO::Fitting a single group.
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0827c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0830(565 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0830 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0831c(566 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0835(567 of 2614)
## 2018-05-16 17:55:59 INFO::Fitting a single group.
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0835 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0838(568 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0840c(569 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0840c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0844c(570 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0845(571 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0845 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0846c(572 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0852(573 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0852 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0853c(574 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0854(575 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0855(576 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0855 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0857(577 of 2614)
## 2018-05-16 17:55:59 INFO::Fitting a single group.
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0857 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0858c(578 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0859(579 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0860(580 of 2614)
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0861c(581 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0861c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0862c(582 of 2614)
## 2018-05-16 17:55:59 WARNING::Results of protein 1/Rv0862c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:55:59 INFO::Testing a comparison of protein: 1/Rv0863(583 of 2614)
## 
  |                                                                       
  |===============                                                  |  22%2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0864(584 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0865(585 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0865 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0868c(586 of 2614)
## 2018-05-16 17:56:00 INFO::Fitting a single group.
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0868c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0871(587 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0873(588 of 2614)
## 
  |                                                                       
  |===============                                                  |  23%2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0875c(589 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0875c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0876c(590 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0876c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0877(591 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0880(592 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0880 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0883c(593 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0883c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0884c(594 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0886(595 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0886 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0887c(596 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0888(597 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0889c(598 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0890c(599 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0890c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0892(600 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0892 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0893c(601 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0893c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0896(602 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0897c(603 of 2614)
## 2018-05-16 17:56:00 WARNING::Results of protein 1/Rv0897c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0898c(604 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0899(605 of 2614)
## 2018-05-16 17:56:00 INFO::Testing a comparison of protein: 1/Rv0901(606 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0902c(607 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0902c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0903c(608 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0904c(609 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0905(610 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0906(611 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0906 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0907(612 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0908(613 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0908 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0909(614 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0909 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============                                                  |  24%2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0910(615 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0910 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0911(616 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0913c(617 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0913c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0914c(618 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0923c(619 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0923c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0925c(620 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0926c(621 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0926c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0927c(622 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0928(623 of 2614)
## 
  |                                                                       
  |================                                                 |  24%2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0931c(624 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0932c(625 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0933(626 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0933 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0934(627 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0936(628 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0936 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0937c(629 of 2614)
## 2018-05-16 17:56:01 INFO::Testing a comparison of protein: 1/Rv0938(630 of 2614)
## 2018-05-16 17:56:01 WARNING::Results of protein 1/Rv0938 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0939(631 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0940c(632 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0941c(633 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0941c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0946c(634 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0948c(635 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0949(636 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0949 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0951(637 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0952(638 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0953c(639 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0953c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0954(640 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0954 for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |================                                                 |  25%2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0956(641 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0956 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0957(642 of 2614)
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0958(643 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0958 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0959(644 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0959 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0959A(645 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0959A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0960(646 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0960 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0966c(647 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0966c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0967(648 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0967 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0968(649 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0968 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0969(650 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0969 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:02 INFO::Testing a comparison of protein: 1/Rv0971c(651 of 2614)
## 2018-05-16 17:56:02 WARNING::Results of protein 1/Rv0971c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0972c(652 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0973c(653 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0974c(654 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0974c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0979A(655 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0979A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0981(656 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0981 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0982(657 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0982 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0983(658 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0984(659 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0985c(660 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0985c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0986(661 of 2614)
## 2018-05-16 17:56:03 INFO::Fitting a single group.
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0986 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0989c(662 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0989c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0991c(663 of 2614)
## 
  |                                                                       
  |=================                                                |  25%2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0992c(664 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0992c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0993(665 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0993 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0994(666 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0994 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=================                                                |  26%2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0997a(667 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0997a for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0998(668 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv0998 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv0999(669 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv1001(670 of 2614)
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv1002c(671 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv1002c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv1003(672 of 2614)
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv1003 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv1005c(673 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:03 WARNING::Results of protein 1/Rv1005c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:03 INFO::Testing a comparison of protein: 1/Rv1006(674 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1007c(675 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1008(676 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1008 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1009(677 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1010(678 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1010 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1011(679 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1011 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1013(680 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1013 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1015c(681 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1016c(682 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1017c(683 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1018c(684 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1019(685 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1019 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1020(686 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1020 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1021(687 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1022(688 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1022 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1023(689 of 2614)
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1024(690 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1024 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1025(691 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1025 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1026(692 of 2614)
## 2018-05-16 17:56:04 INFO::Fitting a single group.
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1026 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=================                                                |  27%2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1028c(693 of 2614)
## 2018-05-16 17:56:04 INFO::Fitting a single group.
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1028c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1030(694 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1030 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1032c(695 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1032c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1033c(696 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1033c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1043c(697 of 2614)
## 2018-05-16 17:56:04 INFO::Fitting a single group.
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1043c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:04 INFO::Testing a comparison of protein: 1/Rv1045(698 of 2614)
## 2018-05-16 17:56:04 WARNING::Results of protein 1/Rv1045 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1048c(699 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1048c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1050(700 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1050 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1056(701 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1058(702 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1059(703 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1059 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================                                               |  27%2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1060(704 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1060 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1061(705 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1061 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1062(706 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1062 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1063c(707 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1063c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1069c(708 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1069c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1070c(709 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1071c(710 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1072(711 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1072 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1074c(712 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1077(713 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1078(714 of 2614)
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1078 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1079(715 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1080c(716 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1082(717 of 2614)
## 2018-05-16 17:56:05 INFO::Testing a comparison of protein: 1/Rv1083(718 of 2614)
## 2018-05-16 17:56:05 INFO::Fitting a single group.
## 2018-05-16 17:56:05 WARNING::Results of protein 1/Rv1083 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================                                               |  28%2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1084(719 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1084 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1086(720 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1086 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1087(721 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1087 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1092c(722 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1092c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1093(723 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1094(724 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1095(725 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1095 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1096(726 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1097c(727 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1098c(728 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1099c(729 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1100(730 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1101c(731 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1101c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1106c(732 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1106c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1107c(733 of 2614)
## 2018-05-16 17:56:06 INFO::Fitting a single group.
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1107c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1108c(734 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1108c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1109c(735 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1110(736 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1110 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1111c(737 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1111c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1112(738 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1112 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1113(739 of 2614)
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1117(740 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1117 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:06 INFO::Testing a comparison of protein: 1/Rv1118c(741 of 2614)
## 2018-05-16 17:56:06 WARNING::Results of protein 1/Rv1118c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1121(742 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1122(743 of 2614)
## 
  |                                                                       
  |===================                                              |  28%2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1123c(744 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1123c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===================                                              |  29%2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1124(745 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1124 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1125(746 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1125 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1126c(747 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1126c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1127c(748 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1127c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1130(749 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1130 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1132(750 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1132 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1133c(751 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1140(752 of 2614)
## 2018-05-16 17:56:07 INFO::Fitting a single group.
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1140 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1141c(753 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1141c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1142c(754 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1142c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1143(755 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1144(756 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1147(757 of 2614)
## 2018-05-16 17:56:07 INFO::Fitting a single group.
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1147 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1151c(758 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1151c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1152(759 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1152 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1154c(760 of 2614)
## 2018-05-16 17:56:07 INFO::Fitting a single group.
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1154c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1155(761 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1155a(762 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1156(763 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1156 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1157c(764 of 2614)
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1159A(765 of 2614)
## 2018-05-16 17:56:07 WARNING::Results of protein 1/Rv1159A for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:07 INFO::Testing a comparison of protein: 1/Rv1160(766 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1160 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1161(767 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1161 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1162(768 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1162 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1164(769 of 2614)
## 2018-05-16 17:56:08 INFO::Fitting a single group.
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1164 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1165(770 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1165 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1166(771 of 2614)
## 
  |                                                                       
  |===================                                              |  30%2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1167c(772 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1167c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1170(773 of 2614)
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1172c(774 of 2614)
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1173(775 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1173 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1174c(776 of 2614)
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1175c(777 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1175c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1176c(778 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1176c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1177(779 of 2614)
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1178(780 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1178 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1179c(781 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1179c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1180(782 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1180 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1181(783 of 2614)
## 2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1182(784 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1182 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |====================                                             |  30%2018-05-16 17:56:08 INFO::Testing a comparison of protein: 1/Rv1183(785 of 2614)
## 2018-05-16 17:56:08 WARNING::Results of protein 1/Rv1183 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1184c(786 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1185c(787 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1187(788 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1188(789 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1188 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1191(790 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1191 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1192(791 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1192 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1193(792 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1193 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1194c(793 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1194c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1196(794 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1198(795 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1201c(796 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1202(797 of 2614)
## 
  |                                                                       
  |====================                                             |  31%2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1204c(798 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1204c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1206(799 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1206 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1207(800 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1207 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1208(801 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1208 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1209(802 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1209 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1210(803 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1210 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1211(804 of 2614)
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1212c(805 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1212c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1213(806 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1213 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1215c(807 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1215c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:09 INFO::Testing a comparison of protein: 1/Rv1218c(808 of 2614)
## 2018-05-16 17:56:09 WARNING::Results of protein 1/Rv1218c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1220c(809 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1220c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1223(810 of 2614)
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1224(811 of 2614)
## 2018-05-16 17:56:10 INFO::Fitting a single group.
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1224 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1226c(812 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1226c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1227c(813 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1227c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1229c(814 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1229c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1231c(815 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1231c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1232c(816 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1232c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1234(817 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1234 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1235(818 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1235 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1237(819 of 2614)
## 2018-05-16 17:56:10 INFO::Fitting a single group.
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1237 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1238(820 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1238 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1239c(821 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1239c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1240(822 of 2614)
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1241(823 of 2614)
## 
  |                                                                       
  |====================                                             |  32%2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1244(824 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1244 for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |=====================                                            |  32%2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1245c(825 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1245c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1246c(826 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1246c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1247c(827 of 2614)
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1248c(828 of 2614)
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1249c(829 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1249c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1251c(830 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1251c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1253(831 of 2614)
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1255c(832 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1255c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:10 INFO::Testing a comparison of protein: 1/Rv1256c(833 of 2614)
## 2018-05-16 17:56:10 WARNING::Results of protein 1/Rv1256c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1257c(834 of 2614)
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1259(835 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1259 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1260(836 of 2614)
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1261c(837 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1261c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1263(838 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1263 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1264(839 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1264 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1265(840 of 2614)
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1266c(841 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1266c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1267c(842 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1267c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1269c(843 of 2614)
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1270c(844 of 2614)
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1273c(845 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1273c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1274(846 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1274 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1275(847 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1275 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1276c(848 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1276c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1277(849 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1277 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=====================                                            |  33%2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1278(850 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1278 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1279(851 of 2614)
## 2018-05-16 17:56:11 WARNING::Results of protein 1/Rv1279 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:11 INFO::Testing a comparison of protein: 1/Rv1280c(852 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1281c(853 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1281c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1283c(854 of 2614)
## 2018-05-16 17:56:12 INFO::Fitting a single group.
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1283c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1284(855 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1285(856 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1285 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1286(857 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1286 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1287(858 of 2614)
## 2018-05-16 17:56:12 INFO::Fitting a single group.
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1287 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1288(859 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1288 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1289(860 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1289 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1290c(861 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1290c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1292(862 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1293(863 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1294(864 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1294 for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |======================                                           |  33%2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1295(865 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1296(866 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1297(867 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1298(868 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1299(869 of 2614)
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1301(870 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1301 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1302(871 of 2614)
## 2018-05-16 17:56:12 INFO::Fitting a single group.
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1302 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1304(872 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1304 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1306(873 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1306 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1307(874 of 2614)
## 2018-05-16 17:56:12 WARNING::Results of protein 1/Rv1307 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:12 INFO::Testing a comparison of protein: 1/Rv1308(875 of 2614)
## 
  |                                                                       
  |======================                                           |  34%2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1309(876 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1310(877 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1311(878 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1312(879 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1312 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1314c(880 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1315(881 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1315 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1316c(882 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1316c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1317c(883 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1317c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1318c(884 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1318c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1320c(885 of 2614)
## 2018-05-16 17:56:13 INFO::Fitting a single group.
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1320c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1321(886 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1321 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1322(887 of 2614)
## 2018-05-16 17:56:13 INFO::Fitting a single group.
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1322 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1322A(888 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1322A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1323(889 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1324(890 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1325c(891 of 2614)
## 2018-05-16 17:56:13 INFO::Fitting a single group.
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1325c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1326c(892 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1327c(893 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1328(894 of 2614)
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1329c(895 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1329c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1330c(896 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1330c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1331(897 of 2614)
## 2018-05-16 17:56:13 INFO::Fitting a single group.
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1331 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1332(898 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1332 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1333(899 of 2614)
## 2018-05-16 17:56:13 WARNING::Results of protein 1/Rv1333 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:13 INFO::Testing a comparison of protein: 1/Rv1334(900 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1335(901 of 2614)
## 
  |                                                                       
  |======================                                           |  35%2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1336(902 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1338(903 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1338 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1339(904 of 2614)
## 
  |                                                                       
  |=======================                                          |  35%2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1340(905 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1341(906 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1345(907 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1345 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1346(908 of 2614)
## 2018-05-16 17:56:14 INFO::Fitting a single group.
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1346 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1347c(909 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1347c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1348(910 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1348 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1349(911 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1349 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1350(912 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1350 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1352(913 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1360(914 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1362c(915 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1362c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1363c(916 of 2614)
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1364c(917 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1364c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1366(918 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1366 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1367c(919 of 2614)
## 2018-05-16 17:56:14 WARNING::Results of protein 1/Rv1367c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:14 INFO::Testing a comparison of protein: 1/Rv1368(920 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1377c(921 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1379(922 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1380(923 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1381(924 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1382(925 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1382 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1383(926 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1383 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1384(927 of 2614)
## 
  |                                                                       
  |=======================                                          |  36%2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1385(928 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1385 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1386(929 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1387(930 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1388(931 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1389(932 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1390(933 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1391(934 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1392(935 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1398c(936 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1399c(937 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1399c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1400c(938 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1400c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1402(939 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1402 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1404(940 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1406(941 of 2614)
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1407(942 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1407 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1408(943 of 2614)
## 2018-05-16 17:56:15 INFO::Fitting a single group.
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1408 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:15 INFO::Testing a comparison of protein: 1/Rv1409(944 of 2614)
## 2018-05-16 17:56:15 WARNING::Results of protein 1/Rv1409 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1411c(945 of 2614)
## 
  |                                                                       
  |========================                                         |  36%2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1412(946 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1415(947 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1415 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1416(948 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1418(949 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1418 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1419(950 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1420(951 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1420 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1421(952 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1421 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1422(953 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1422 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1423(954 of 2614)
## 
  |                                                                       
  |========================                                         |  37%2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1424c(955 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1424c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1425(956 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1425 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1426c(957 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1426c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1427c(958 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1428c(959 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1428c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1429(960 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1429 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1433(961 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1435c(962 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1436(963 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1437(964 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1438(965 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1439c(966 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1439c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1442(967 of 2614)
## 2018-05-16 17:56:16 INFO::Testing a comparison of protein: 1/Rv1443c(968 of 2614)
## 2018-05-16 17:56:16 WARNING::Results of protein 1/Rv1443c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1444c(969 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1444c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1445c(970 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1446c(971 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1446c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1447c(972 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1447c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1448c(973 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1449c(974 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1454c(975 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1454c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1455(976 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1455 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1456c(977 of 2614)
## 2018-05-16 17:56:17 INFO::Fitting a single group.
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1456c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1458c(978 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1458c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1461(979 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1462(980 of 2614)
## 
  |                                                                       
  |========================                                         |  38%2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1463(981 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1464(982 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1465(983 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1465 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1466(984 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1467c(985 of 2614)
## 
  |                                                                       
  |=========================                                        |  38%2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1471(986 of 2614)
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1472(987 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1472 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:17 INFO::Testing a comparison of protein: 1/Rv1473(988 of 2614)
## 2018-05-16 17:56:17 WARNING::Results of protein 1/Rv1473 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1473A(989 of 2614)
## 2018-05-16 17:56:18 INFO::Fitting a single group.
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1473A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1474c(990 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1474c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1475c(991 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1476(992 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1476 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1477(993 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1478(994 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1479(995 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1480(996 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1480 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1481(997 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1481 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1483(998 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1483 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1484(999 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1486c(1000 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1486c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1487(1001 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1487 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1488(1002 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1489(1003 of 2614)
## 2018-05-16 17:56:18 INFO::Fitting a single group.
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1489 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1492(1004 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1492 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1493(1005 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1493 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1494(1006 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1494 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========================                                        |  39%2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1496(1007 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1496 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1497(1008 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1497 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1498A(1009 of 2614)
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1498c(1010 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1498c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1500(1011 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1500 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:18 INFO::Testing a comparison of protein: 1/Rv1501(1012 of 2614)
## 2018-05-16 17:56:18 WARNING::Results of protein 1/Rv1501 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1502(1013 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1502 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1507c(1014 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1507c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1508c(1015 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1508c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1511(1016 of 2614)
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1512(1017 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1512 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1513(1018 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1513 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1514c(1019 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1514c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1515c(1020 of 2614)
## 2018-05-16 17:56:19 INFO::Fitting a single group.
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1515c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1516c(1021 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1516c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1521(1022 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1521 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1523(1023 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1523 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1524(1024 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1524 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1527c(1025 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1527c for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |==========================                                       |  39%2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1529(1026 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1529 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1530(1027 of 2614)
## 2018-05-16 17:56:19 INFO::Fitting a single group.
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1530 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1531(1028 of 2614)
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1532c(1029 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1532c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1533(1030 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1533 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1534(1031 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1534 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1535(1032 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1535 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==========================                                       |  40%2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1536(1033 of 2614)
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1538c(1034 of 2614)
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1540(1035 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1540 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1543(1036 of 2614)
## 2018-05-16 17:56:19 WARNING::Results of protein 1/Rv1543 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:19 INFO::Testing a comparison of protein: 1/Rv1544(1037 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1546(1038 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1547(1039 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1547 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1556(1040 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1558(1041 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1559(1042 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1561(1043 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1561 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1562c(1044 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1562c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1563c(1045 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1563c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1564c(1046 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1565c(1047 of 2614)
## 2018-05-16 17:56:20 INFO::Fitting a single group.
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1565c for comparison whole
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1566c(1048 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1569(1049 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1569 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1570(1050 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1570 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1571(1051 of 2614)
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1576c(1052 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1576c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1578c(1053 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1578c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1586c(1054 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1586c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1589(1055 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1589 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1590(1056 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1590 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:20 INFO::Testing a comparison of protein: 1/Rv1591(1057 of 2614)
## 2018-05-16 17:56:20 WARNING::Results of protein 1/Rv1591 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1592c(1058 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1592c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==========================                                       |  41%2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1593c(1059 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1593c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1594(1060 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1595(1061 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1596(1062 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1597(1063 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1597 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1598c(1064 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1598c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1599(1065 of 2614)
## 
  |                                                                       
  |===========================                                      |  41%2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1600(1066 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1600 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1601(1067 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1602(1068 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1602 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1603(1069 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1605(1070 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1605 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1606(1071 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1608c(1072 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1609(1073 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1610(1074 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1610 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1611(1075 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1612(1076 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1613(1077 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1614(1078 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1614 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1615(1079 of 2614)
## 2018-05-16 17:56:21 INFO::Fitting a single group.
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1615 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1617(1080 of 2614)
## 2018-05-16 17:56:21 INFO::Testing a comparison of protein: 1/Rv1618(1081 of 2614)
## 2018-05-16 17:56:21 WARNING::Results of protein 1/Rv1618 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1620c(1082 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1620c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1621c(1083 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1621c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1622c(1084 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1622c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===========================                                      |  42%2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1623c(1085 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1625c(1086 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1625c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1626(1087 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1627c(1088 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1628c(1089 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1629(1090 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1630(1091 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1631(1092 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1631 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1632c(1093 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1632c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1633(1094 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1633 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1636(1095 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1637c(1096 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1638(1097 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1638 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1638A(1098 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1640c(1099 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1640c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1641(1100 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1642(1101 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1642 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1643(1102 of 2614)
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1647(1103 of 2614)
## 2018-05-16 17:56:22 WARNING::Results of protein 1/Rv1647 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:22 INFO::Testing a comparison of protein: 1/Rv1649(1104 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1650(1105 of 2614)
## 
  |                                                                       
  |============================                                     |  42%2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1652(1106 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1653(1107 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1654(1108 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1654 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1655(1109 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1656(1110 of 2614)
## 
  |                                                                       
  |============================                                     |  43%2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1657(1111 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1658(1112 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1658 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1659(1113 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1660(1114 of 2614)
## 2018-05-16 17:56:23 INFO::Fitting a single group.
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1660 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1661(1115 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1661 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1663(1116 of 2614)
## 2018-05-16 17:56:23 INFO::Fitting a single group.
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1663 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1664(1117 of 2614)
## 2018-05-16 17:56:23 INFO::Fitting a single group.
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1664 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1665(1118 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1666c(1119 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1666c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1676(1120 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1676 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1677(1121 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1679(1122 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1679 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1680(1123 of 2614)
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1681(1124 of 2614)
## 2018-05-16 17:56:23 WARNING::Results of protein 1/Rv1681 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:23 INFO::Testing a comparison of protein: 1/Rv1683(1125 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1684(1126 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1685c(1127 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1685c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1686c(1128 of 2614)
## 2018-05-16 17:56:24 INFO::Fitting a single group.
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1686c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1687c(1129 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1687c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1688(1130 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1688 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1689(1131 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1691(1132 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1691 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1692(1133 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1692 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1695(1134 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1696(1135 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1696 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1697(1136 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1697 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1698(1137 of 2614)
## 
  |                                                                       
  |============================                                     |  44%2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1699(1138 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1700(1139 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1701(1140 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1701 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1703c(1141 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1704c(1142 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1704c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1707(1143 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1707 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1708(1144 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1708 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1710(1145 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1710 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1711(1146 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1711 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================                                    |  44%2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1712(1147 of 2614)
## 2018-05-16 17:56:24 INFO::Testing a comparison of protein: 1/Rv1713(1148 of 2614)
## 2018-05-16 17:56:24 WARNING::Results of protein 1/Rv1713 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1719(1149 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1719 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1721c(1150 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1722(1151 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1722 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1727(1152 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1727 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1729c(1153 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1730c(1154 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1730c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1731(1155 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1731 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1732c(1156 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1738(1157 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1742(1158 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1742 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1743(1159 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1743 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1745c(1160 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1745c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1746(1161 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1747(1162 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1748(1163 of 2614)
## 
  |                                                                       
  |=============================                                    |  45%2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1749c(1164 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1749c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1750c(1165 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1750c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1751(1166 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1751 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1754c(1167 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1762c(1168 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1762c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1767(1169 of 2614)
## 2018-05-16 17:56:25 WARNING::Results of protein 1/Rv1767 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1769(1170 of 2614)
## 2018-05-16 17:56:25 INFO::Testing a comparison of protein: 1/Rv1770(1171 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1771(1172 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1773c(1173 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1773c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1774(1174 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1778c(1175 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1779c(1176 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1779c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1780(1177 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1780 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1781c(1178 of 2614)
## 2018-05-16 17:56:26 INFO::Fitting a single group.
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1781c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1782(1179 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1783(1180 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1785c(1181 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1785c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1789(1182 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1789 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1793(1183 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1794(1184 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1795(1185 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1795 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1796(1186 of 2614)
## 
  |                                                                       
  |==============================                                   |  45%2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1797(1187 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1797 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1798(1188 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1798 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1808(1189 of 2614)
## 
  |                                                                       
  |==============================                                   |  46%2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1809(1190 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1810(1191 of 2614)
## 2018-05-16 17:56:26 INFO::Testing a comparison of protein: 1/Rv1812c(1192 of 2614)
## 2018-05-16 17:56:26 WARNING::Results of protein 1/Rv1812c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1815(1193 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1816(1194 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1816 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1817(1195 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1817 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1819c(1196 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1819c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1820(1197 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1820 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1821(1198 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1821 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1822(1199 of 2614)
## 2018-05-16 17:56:27 INFO::Fitting a single group.
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1822 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1823(1200 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1823 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1825(1201 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1825 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1826(1202 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1827(1203 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1828(1204 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1828 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1829(1205 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1830(1206 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1830 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1832(1207 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1833c(1208 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1833c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1835c(1209 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1835c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1836c(1210 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1837c(1211 of 2614)
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1838c(1212 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1838c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1839c(1213 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1839c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:27 INFO::Testing a comparison of protein: 1/Rv1842c(1214 of 2614)
## 2018-05-16 17:56:27 WARNING::Results of protein 1/Rv1842c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1843c(1215 of 2614)
## 
  |                                                                       
  |==============================                                   |  47%2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1847(1216 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1847 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1848(1217 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1850(1218 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1850 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1852(1219 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1852 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1853(1220 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1853 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1854c(1221 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1854c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1855c(1222 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1856c(1223 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1856c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1860(1224 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1862(1225 of 2614)
## 2018-05-16 17:56:28 INFO::Fitting a single group.
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1862 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1864c(1226 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1864c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================                                  |  47%2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1865c(1227 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1865c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1866(1228 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1866 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1867(1229 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1867 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1868(1230 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1868 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1869c(1231 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1871c(1232 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1871c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1872c(1233 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1874(1234 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1874 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1875(1235 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1876(1236 of 2614)
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1878(1237 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1878 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:28 INFO::Testing a comparison of protein: 1/Rv1880c(1238 of 2614)
## 2018-05-16 17:56:28 WARNING::Results of protein 1/Rv1880c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1881c(1239 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1881c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1882c(1240 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1882c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1885c(1241 of 2614)
## 
  |                                                                       
  |===============================                                  |  48%2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1886c(1242 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1887(1243 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1891(1244 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1893(1245 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1894c(1246 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1894c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1896c(1247 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1896c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1899c(1248 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1900c(1249 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1900c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1901(1250 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1901 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1904(1251 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1904 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1905c(1252 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1905c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1906c(1253 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1908c(1254 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1909c(1255 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1909c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1910c(1256 of 2614)
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1912c(1257 of 2614)
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1912c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:29 INFO::Testing a comparison of protein: 1/Rv1913(1258 of 2614)
## 2018-05-16 17:56:29 INFO::Fitting a single group.
## 2018-05-16 17:56:29 WARNING::Results of protein 1/Rv1913 for comparison whole
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1915(1259 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1915 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1919c(1260 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1919c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1920(1261 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1920 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1922(1262 of 2614)
## 2018-05-16 17:56:30 INFO::Fitting a single group.
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1922 for comparison whole
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1923(1263 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1923 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1924c(1264 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1924c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1925(1265 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1926c(1266 of 2614)
## 
  |                                                                       
  |================================                                 |  48%2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1927(1267 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1927 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |================================                                 |  49%2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1928c(1268 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1928c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1929c(1269 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1929c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1932(1270 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1936(1271 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1938(1272 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1938 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1942c(1273 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1942c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1943c(1274 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1943c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1944c(1275 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1956(1276 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1956 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1957(1277 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1960c(1278 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1960c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1962A(1279 of 2614)
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1962c(1280 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1962c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1963c(1281 of 2614)
## 2018-05-16 17:56:30 WARNING::Results of protein 1/Rv1963c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:30 INFO::Testing a comparison of protein: 1/Rv1975(1282 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1976c(1283 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1976c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1977(1284 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1977 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1978(1285 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1978 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1980c(1286 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1981c(1287 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1982A(1288 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1982A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1983(1289 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1984c(1290 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1987(1291 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1989c(1292 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1989c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1990c(1293 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1990c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |================================                                 |  50%2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1991A(1294 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1991A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1991c(1295 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1991c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1992c(1296 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1992c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1993c(1297 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv1996(1298 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv1996 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2000(1299 of 2614)
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2001(1300 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv2001 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2002(1301 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv2002 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2004c(1302 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv2004c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2005c(1303 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv2005c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:31 INFO::Testing a comparison of protein: 1/Rv2006(1304 of 2614)
## 2018-05-16 17:56:31 WARNING::Results of protein 1/Rv2006 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2007c(1305 of 2614)
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2008c(1306 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2008c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2010(1307 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2010 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=================================                                |  50%2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2012(1308 of 2614)
## 2018-05-16 17:56:32 INFO::Fitting a single group.
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2012 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2018(1309 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2018 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2019(1310 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2019 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2021c(1311 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2021c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2026c(1312 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2026c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2027c(1313 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2027c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2031c(1314 of 2614)
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2035(1315 of 2614)
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2037c(1316 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2037c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2038c(1317 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2038c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2041c(1318 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2041c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2042c(1319 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2042c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2045c(1320 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2045c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=================================                                |  51%2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2047c(1321 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2047c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2048c(1322 of 2614)
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2050(1323 of 2614)
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2051c(1324 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2051c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:32 INFO::Testing a comparison of protein: 1/Rv2052c(1325 of 2614)
## 2018-05-16 17:56:32 WARNING::Results of protein 1/Rv2052c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2054(1326 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2054 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2055c(1327 of 2614)
## 2018-05-16 17:56:33 INFO::Fitting a single group.
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2055c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2061c(1328 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2061c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2062c(1329 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2062c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2063A(1330 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2064(1331 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2064 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2065(1332 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2065 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2066(1333 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2066 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2067c(1334 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2067c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2068c(1335 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2070c(1336 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2070c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2071c(1337 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2073c(1338 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2073c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2074(1339 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2080(1340 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2082(1341 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2082 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2083(1342 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2083 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2089c(1343 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2090(1344 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2090 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2091c(1345 of 2614)
## 2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2092c(1346 of 2614)
## 
  |                                                                       
  |=================================                                |  52%2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2094c(1347 of 2614)
## 
  |                                                                       
  |==================================                               |  52%2018-05-16 17:56:33 INFO::Testing a comparison of protein: 1/Rv2095c(1348 of 2614)
## 2018-05-16 17:56:33 WARNING::Results of protein 1/Rv2095c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2096c(1349 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2096c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2097c(1350 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2097c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2101(1351 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2101 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2102(1352 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2102 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2103c(1353 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2103c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2104c(1354 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2104c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2109c(1355 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2110c(1356 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2111c(1357 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2112c(1358 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2112c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2113(1359 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2113 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2114(1360 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2114 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2115c(1361 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2115c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2116(1362 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2116 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2117(1363 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2117 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2118c(1364 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2121c(1365 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2122c(1366 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2124c(1367 of 2614)
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2125(1368 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2125 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2129c(1369 of 2614)
## 2018-05-16 17:56:34 WARNING::Results of protein 1/Rv2129c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:34 INFO::Testing a comparison of protein: 1/Rv2130c(1370 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2131c(1371 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2131c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2132(1372 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2132 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================================                               |  53%2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2134c(1373 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2135c(1374 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2137c(1375 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2137c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2138(1376 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2139(1377 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2139 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2140c(1378 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2141c(1379 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2142c(1380 of 2614)
## 2018-05-16 17:56:35 INFO::Fitting a single group.
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2142c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2145c(1381 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2147c(1382 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2147c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2148c(1383 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2148c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2149c(1384 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2149c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2150c(1385 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2151c(1386 of 2614)
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2152c(1387 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2152c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===================================                              |  53%2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2153c(1388 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2153c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2155c(1389 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2155c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2157c(1390 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2157c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:35 INFO::Testing a comparison of protein: 1/Rv2158c(1391 of 2614)
## 2018-05-16 17:56:35 WARNING::Results of protein 1/Rv2158c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2159c(1392 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2161c(1393 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2161c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2162c(1394 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2163c(1395 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2164c(1396 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2165c(1397 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2165c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2166c(1398 of 2614)
## 
  |                                                                       
  |===================================                              |  54%2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2169c(1399 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2169c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2170(1400 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2170 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2171(1401 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2171 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2172c(1402 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2172c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2173(1403 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2173 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2174(1404 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2174 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2175c(1405 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2176(1406 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2176 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2178c(1407 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2178c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2179c(1408 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2179c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2182c(1409 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2182c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2183c(1410 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2183c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2184c(1411 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2184c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2185c(1412 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2187(1413 of 2614)
## 2018-05-16 17:56:36 INFO::Testing a comparison of protein: 1/Rv2188c(1414 of 2614)
## 2018-05-16 17:56:36 WARNING::Results of protein 1/Rv2188c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2190c(1415 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2192c(1416 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2192c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2194(1417 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2195(1418 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2196(1419 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2196 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2198c(1420 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2200c(1421 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2201(1422 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2201 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2202c(1423 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2203(1424 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2203 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===================================                              |  55%2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2204c(1425 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2206(1426 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2206 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2207(1427 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2207 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |====================================                             |  55%2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2210c(1428 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2211c(1429 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2212(1430 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2212 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2213(1431 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2214c(1432 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2215(1433 of 2614)
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2216(1434 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2216 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2217(1435 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2217 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:37 INFO::Testing a comparison of protein: 1/Rv2218(1436 of 2614)
## 2018-05-16 17:56:37 WARNING::Results of protein 1/Rv2218 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2219(1437 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2219 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2220(1438 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2221c(1439 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2221c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2222c(1440 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2223c(1441 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2224c(1442 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2226(1443 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2228c(1444 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2229c(1445 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2230c(1446 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2231c(1447 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2231c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2232(1448 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2232 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2235(1449 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2235 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2237(1450 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2237 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |====================================                             |  56%2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2237A(1451 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2238c(1452 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2240c(1453 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2241(1454 of 2614)
## 2018-05-16 17:56:38 INFO::Testing a comparison of protein: 1/Rv2242(1455 of 2614)
## 2018-05-16 17:56:38 WARNING::Results of protein 1/Rv2242 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2243(1456 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2244(1457 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2245(1458 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2246(1459 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2247(1460 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2247 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2249c(1461 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2249c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2251(1462 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2252(1463 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2252 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2253(1464 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2256c(1465 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2256c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2257c(1466 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2258c(1467 of 2614)
## 
  |                                                                       
  |=====================================                            |  56%2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2259(1468 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2260(1469 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2260 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2263(1470 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2263 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2264c(1471 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2264c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2271(1472 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2276(1473 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2276 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2280(1474 of 2614)
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2282c(1475 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2282c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2284(1476 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2284 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=====================================                            |  57%2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2285(1477 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2285 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2287(1478 of 2614)
## 2018-05-16 17:56:39 WARNING::Results of protein 1/Rv2287 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:39 INFO::Testing a comparison of protein: 1/Rv2289(1479 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2290(1480 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2291(1481 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2291 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2294(1482 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2295(1483 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2295 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2296(1484 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2296 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2297(1485 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2297 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2298(1486 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2298 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2299c(1487 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2300c(1488 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2300c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2301(1489 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2302(1490 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2303c(1491 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2303c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2305(1492 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2305 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2307c(1493 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2313c(1494 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2313c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2314c(1495 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2315c(1496 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2325c(1497 of 2614)
## 2018-05-16 17:56:40 INFO::Fitting a single group.
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2325c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2326c(1498 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2326c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2327(1499 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2332(1500 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2332 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2334(1501 of 2614)
## 2018-05-16 17:56:40 INFO::Testing a comparison of protein: 1/Rv2336(1502 of 2614)
## 2018-05-16 17:56:40 WARNING::Results of protein 1/Rv2336 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2337c(1503 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2337c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=====================================                            |  58%2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2338c(1504 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2338c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2339(1505 of 2614)
## 2018-05-16 17:56:41 INFO::Fitting a single group.
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2339 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2342(1506 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2342 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2343c(1507 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2343c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2344c(1508 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2344c for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |======================================                           |  58%2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2345(1509 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2346c(1510 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2349c(1511 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2350c(1512 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2351c(1513 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2351c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2352c(1514 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2357c(1515 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2358(1516 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2359(1517 of 2614)
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2360c(1518 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2360c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2361c(1519 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2361c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2363(1520 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2363 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2365c(1521 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2365c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:41 INFO::Testing a comparison of protein: 1/Rv2366c(1522 of 2614)
## 2018-05-16 17:56:41 WARNING::Results of protein 1/Rv2366c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2368c(1523 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2368c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2373c(1524 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2374c(1525 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2374c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2375(1526 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2375 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2376c(1527 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2377c(1528 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2377c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2378c(1529 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2378c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======================================                           |  59%2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2379c(1530 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2379c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2380c(1531 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2380c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2382c(1532 of 2614)
## 2018-05-16 17:56:42 INFO::Fitting a single group.
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2382c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2383c(1533 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2383c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2386c(1534 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2386c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2391(1535 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2392(1536 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2392 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2394(1537 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2397c(1538 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2397c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2400c(1539 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2402(1540 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2403c(1541 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2403c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2404c(1542 of 2614)
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2405(1543 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2405 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2406c(1544 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2406c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:42 INFO::Testing a comparison of protein: 1/Rv2409c(1545 of 2614)
## 2018-05-16 17:56:42 WARNING::Results of protein 1/Rv2409c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2410c(1546 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2410c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2411c(1547 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2411c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2412(1548 of 2614)
## 
  |                                                                       
  |=======================================                          |  59%2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2413c(1549 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2413c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2416c(1550 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2417c(1551 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2417c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2418c(1552 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2418c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2419c(1553 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2420c(1554 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2420c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2421c(1555 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2421c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=======================================                          |  60%2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2423(1556 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2423 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2425c(1557 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2425c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2426c(1558 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2426c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2427c(1559 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2428(1560 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2429(1561 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2430c(1562 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2431c(1563 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2436(1564 of 2614)
## 2018-05-16 17:56:43 INFO::Fitting a single group.
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2436 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2438c(1565 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2439c(1566 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2439c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2440c(1567 of 2614)
## 2018-05-16 17:56:43 WARNING::Results of protein 1/Rv2440c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2441c(1568 of 2614)
## 2018-05-16 17:56:43 INFO::Testing a comparison of protein: 1/Rv2442c(1569 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2444c(1570 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2445c(1571 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2447c(1572 of 2614)
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2447c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2448c(1573 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2449c(1574 of 2614)
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2449c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2453c(1575 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2454c(1576 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2455c(1577 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2457c(1578 of 2614)
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2457c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2458(1579 of 2614)
## 2018-05-16 17:56:44 INFO::Fitting a single group.
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2458 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2460c(1580 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2461c(1581 of 2614)
## 
  |                                                                       
  |=======================================                          |  61%2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2462c(1582 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2463(1583 of 2614)
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2463 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2464c(1584 of 2614)
## 2018-05-16 17:56:44 WARNING::Results of protein 1/Rv2464c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2465c(1585 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2466c(1586 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2467(1587 of 2614)
## 2018-05-16 17:56:44 INFO::Testing a comparison of protein: 1/Rv2468c(1588 of 2614)
## 
  |                                                                       
  |========================================                         |  61%2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2470(1589 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2471(1590 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2471 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2473(1591 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2473 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2474c(1592 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2474c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2476c(1593 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2477c(1594 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2482c(1595 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2482c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2483c(1596 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2483c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2484c(1597 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2484c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2486(1598 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2488c(1599 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2488c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2493(1600 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2495c(1601 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2496c(1602 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2496c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2497c(1603 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2497c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2498c(1604 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2499c(1605 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2499c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2500c(1606 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2500c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2501c(1607 of 2614)
## 
  |                                                                       
  |========================================                         |  62%2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2502c(1608 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2502c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2503c(1609 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2504c(1610 of 2614)
## 2018-05-16 17:56:45 INFO::Testing a comparison of protein: 1/Rv2509(1611 of 2614)
## 2018-05-16 17:56:45 WARNING::Results of protein 1/Rv2509 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2510c(1612 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2510c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2511(1613 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2515c(1614 of 2614)
## 2018-05-16 17:56:46 INFO::Fitting a single group.
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2515c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2516c(1615 of 2614)
## 2018-05-16 17:56:46 INFO::Fitting a single group.
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2516c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2518c(1616 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2520c(1617 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2521(1618 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2522c(1619 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2522c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2524c(1620 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2525c(1621 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2526(1622 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2526 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2527(1623 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2528c(1624 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2529(1625 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2529 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2530A(1626 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2531c(1627 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2531c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2532c(1628 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2532c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========================================                        |  62%2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2533c(1629 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2534c(1630 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2535c(1631 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2536(1632 of 2614)
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2538c(1633 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2538c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========================================                        |  63%2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2539c(1634 of 2614)
## 2018-05-16 17:56:46 WARNING::Results of protein 1/Rv2539c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:46 INFO::Testing a comparison of protein: 1/Rv2540c(1635 of 2614)
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2548A(1636 of 2614)
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2553c(1637 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2553c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2554c(1638 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2554c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2555c(1639 of 2614)
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2556c(1640 of 2614)
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2557(1641 of 2614)
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2558(1642 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2558 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2559c(1643 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2559c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2563(1644 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2563 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2564(1645 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2564 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2565(1646 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2565 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2566(1647 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2566 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2567(1648 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2567 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2568c(1649 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2568c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2569c(1650 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2569c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2570(1651 of 2614)
## 2018-05-16 17:56:47 INFO::Fitting a single group.
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2570 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2571c(1652 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2571c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2572c(1653 of 2614)
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2572c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:47 INFO::Testing a comparison of protein: 1/Rv2573(1654 of 2614)
## 2018-05-16 17:56:47 INFO::Fitting a single group.
## 2018-05-16 17:56:47 WARNING::Results of protein 1/Rv2573 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2574(1655 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2574 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2575(1656 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2576c(1657 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2579(1658 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2580c(1659 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2580c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========================================                        |  64%2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2581c(1660 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2581c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2582(1661 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2583c(1662 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2583c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2584c(1663 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2584c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2585c(1664 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2585c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2586c(1665 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2586c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2587c(1666 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2588c(1667 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2588c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2589(1668 of 2614)
## 
  |                                                                       
  |==========================================                       |  64%2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2590(1669 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2592c(1670 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2592c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2593c(1671 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2593c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2595(1672 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2597(1673 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2597 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2598(1674 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2598 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2601A(1675 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2601A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2603c(1676 of 2614)
## 2018-05-16 17:56:48 INFO::Testing a comparison of protein: 1/Rv2604c(1677 of 2614)
## 2018-05-16 17:56:48 WARNING::Results of protein 1/Rv2604c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2605c(1678 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2606c(1679 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2607(1680 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2609c(1681 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2609c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2610c(1682 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2610c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2611c(1683 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2611c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2612c(1684 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2612c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2613c(1685 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2613c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2614c(1686 of 2614)
## 
  |                                                                       
  |==========================================                       |  65%2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2616(1687 of 2614)
## 2018-05-16 17:56:49 INFO::Fitting a single group.
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2616 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2618(1688 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2618 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2619c(1689 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2622(1690 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2622 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2623(1691 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2623 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2624c(1692 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2624c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2626c(1693 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2629(1694 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2629 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2632c(1695 of 2614)
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2633c(1696 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2633c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2637(1697 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2637 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2641(1698 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2641 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:49 INFO::Testing a comparison of protein: 1/Rv2643(1699 of 2614)
## 2018-05-16 17:56:49 WARNING::Results of protein 1/Rv2643 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2650c(1700 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2650c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2658c(1701 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2658c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2664(1702 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2664 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2667(1703 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2667 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2668(1704 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2670c(1705 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2670c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2671(1706 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2671 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2672(1707 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2673(1708 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2673 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2674(1709 of 2614)
## 
  |                                                                       
  |===========================================                      |  65%2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2675c(1710 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2676c(1711 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2677c(1712 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2677c for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |===========================================                      |  66%2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2678c(1713 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2678c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2679(1714 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2680(1715 of 2614)
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2681(1716 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2681 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2682c(1717 of 2614)
## 2018-05-16 17:56:50 WARNING::Results of protein 1/Rv2682c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:50 INFO::Testing a comparison of protein: 1/Rv2683(1718 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2689c(1719 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2689c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2690c(1720 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2690c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2691(1721 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2692(1722 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2694c(1723 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2695(1724 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2695 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2696c(1725 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2697c(1726 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2698(1727 of 2614)
## 2018-05-16 17:56:51 INFO::Fitting a single group.
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2698 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2699c(1728 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2700(1729 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2701c(1730 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2701c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2702(1731 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2702 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2703(1732 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2704(1733 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2704 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2705c(1734 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2705c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2708c(1735 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2708c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2709(1736 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2709 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2710(1737 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2710 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2711(1738 of 2614)
## 
  |                                                                       
  |===========================================                      |  67%2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2713(1739 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2713 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2714(1740 of 2614)
## 2018-05-16 17:56:51 INFO::Testing a comparison of protein: 1/Rv2715(1741 of 2614)
## 2018-05-16 17:56:51 WARNING::Results of protein 1/Rv2715 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2717c(1742 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2717c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2718c(1743 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2718c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2720(1744 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2721c(1745 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2724c(1746 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2724c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2725c(1747 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2725c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2726c(1748 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2727c(1749 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2727c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |============================================                     |  67%2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2728c(1750 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2728c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2731(1751 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2732c(1752 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2732c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2733c(1753 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2733c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2734(1754 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2734 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2737c(1755 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2737c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2738c(1756 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2738c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2739c(1757 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2739c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2740(1758 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2740 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2743c(1759 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2743c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2744c(1760 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2748c(1761 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2748c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2749(1762 of 2614)
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2750(1763 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2750 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2751(1764 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2751 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |============================================                     |  68%2018-05-16 17:56:52 INFO::Testing a comparison of protein: 1/Rv2752c(1765 of 2614)
## 2018-05-16 17:56:52 WARNING::Results of protein 1/Rv2752c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2753c(1766 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2754c(1767 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2756c(1768 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2756c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2759c(1769 of 2614)
## 2018-05-16 17:56:53 INFO::Fitting a single group.
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2759c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2760c(1770 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2763c(1771 of 2614)
## 2018-05-16 17:56:53 INFO::Fitting a single group.
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2763c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2764c(1772 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2764c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2765(1773 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2766c(1774 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2766c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2771c(1775 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2771c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2772c(1776 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2772c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2773c(1777 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2775(1778 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2775 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2778c(1779 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2778c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2780(1780 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2781c(1781 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2781c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2782c(1782 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2782c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2783c(1783 of 2614)
## 2018-05-16 17:56:53 INFO::Testing a comparison of protein: 1/Rv2785c(1784 of 2614)
## 2018-05-16 17:56:53 WARNING::Results of protein 1/Rv2785c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2786c(1785 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2786c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2788(1786 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2789c(1787 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2789c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2790c(1788 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2793c(1789 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2793c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================================                    |  68%2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2794c(1790 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2794c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================================                    |  69%2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2795c(1791 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2795c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2796c(1792 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2799(1793 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2800(1794 of 2614)
## 2018-05-16 17:56:54 INFO::Fitting a single group.
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2800 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2801c(1795 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2801c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2802c(1796 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2802c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2803(1797 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2803 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2808(1798 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2808 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2818c(1799 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2821c(1800 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2821c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2824c(1801 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2824c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2826c(1802 of 2614)
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2826c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2827c(1803 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2827c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2829c(1804 of 2614)
## 2018-05-16 17:56:54 INFO::Fitting a single group.
## 2018-05-16 17:56:54 WARNING::Results of protein 1/Rv2829c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2831(1805 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2837c(1806 of 2614)
## 2018-05-16 17:56:54 INFO::Testing a comparison of protein: 1/Rv2838c(1807 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2839c(1808 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2841c(1809 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2842c(1810 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2842c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2843(1811 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2843 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2844(1812 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2844 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2845c(1813 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2847c(1814 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2847c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2848c(1815 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2848c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2849c(1816 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2849c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================================                    |  70%2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2850c(1817 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2850c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2851c(1818 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2851c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2852c(1819 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2852c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2854(1820 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2854 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2855(1821 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2857c(1822 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2858c(1823 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2859c(1824 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2860c(1825 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2861c(1826 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2864c(1827 of 2614)
## 2018-05-16 17:56:55 INFO::Fitting a single group.
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2864c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2865(1828 of 2614)
## 2018-05-16 17:56:55 WARNING::Results of protein 1/Rv2865 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2868c(1829 of 2614)
## 
  |                                                                       
  |==============================================                   |  70%2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2869c(1830 of 2614)
## 2018-05-16 17:56:55 INFO::Testing a comparison of protein: 1/Rv2870c(1831 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2870c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2871(1832 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2871 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2873(1833 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2875(1834 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2878c(1835 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2882c(1836 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2883c(1837 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2887(1838 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2887 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2888c(1839 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2889c(1840 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2890c(1841 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2893(1842 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2893 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==============================================                   |  71%2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2895c(1843 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2899c(1844 of 2614)
## 2018-05-16 17:56:56 INFO::Fitting a single group.
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2899c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2900c(1845 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2900c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2901c(1846 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2902c(1847 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2902c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2903c(1848 of 2614)
## 2018-05-16 17:56:56 WARNING::Results of protein 1/Rv2903c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2904c(1849 of 2614)
## 2018-05-16 17:56:56 INFO::Testing a comparison of protein: 1/Rv2905(1850 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2906c(1851 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2906c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2907c(1852 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2907c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2908c(1853 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2909c(1854 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2911(1855 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2913c(1856 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2913c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2914c(1857 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2914c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2915c(1858 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2915c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2916c(1859 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2916c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2918c(1860 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2918c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2919c(1861 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2921c(1862 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2921c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2922A(1863 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2922c(1864 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2923c(1865 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2925c(1866 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2926c(1867 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2927c(1868 of 2614)
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2928(1869 of 2614)
## 
  |                                                                       
  |==============================================                   |  72%2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2930(1870 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2930 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================================                  |  72%2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2931(1871 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2931 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2932(1872 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2932 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:57 INFO::Testing a comparison of protein: 1/Rv2933(1873 of 2614)
## 2018-05-16 17:56:57 WARNING::Results of protein 1/Rv2933 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2934(1874 of 2614)
## 2018-05-16 17:56:58 INFO::Fitting a single group.
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2934 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2935(1875 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2935 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2936(1876 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2936 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2939(1877 of 2614)
## 2018-05-16 17:56:58 INFO::Fitting a single group.
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2939 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2940c(1878 of 2614)
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2941(1879 of 2614)
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2942(1880 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2942 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2945c(1881 of 2614)
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2946c(1882 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2946c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2947c(1883 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2947c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2948c(1884 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2948c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2949c(1885 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2949c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2950c(1886 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2950c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2951c(1887 of 2614)
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2952(1888 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2952 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2953(1889 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2953 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2954c(1890 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2954c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2955c(1891 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2955c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2956(1892 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2956 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2957(1893 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2957 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2958c(1894 of 2614)
## 2018-05-16 17:56:58 INFO::Fitting a single group.
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2958c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2959c(1895 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2959c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================================                  |  73%2018-05-16 17:56:58 INFO::Testing a comparison of protein: 1/Rv2962c(1896 of 2614)
## 2018-05-16 17:56:58 WARNING::Results of protein 1/Rv2962c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2965c(1897 of 2614)
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2966c(1898 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2966c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2967c(1899 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2967c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2969c(1900 of 2614)
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2970c(1901 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2970c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2971(1902 of 2614)
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2975a(1903 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2975a for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2976c(1904 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2976c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2977c(1905 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2977c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2980(1906 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2980 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2981c(1907 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2981c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2982c(1908 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2982c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2984(1909 of 2614)
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2985(1910 of 2614)
## 
  |                                                                       
  |================================================                 |  73%2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2986c(1911 of 2614)
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2987c(1912 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2987c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2988c(1913 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2988c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2989(1914 of 2614)
## 2018-05-16 17:56:59 WARNING::Results of protein 1/Rv2989 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:56:59 INFO::Testing a comparison of protein: 1/Rv2991(1915 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2992c(1916 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2993c(1917 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2995c(1918 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2996c(1919 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2997(1920 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv2997 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv2999(1921 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv2999 for comparison whole are NA because there are measurements only in group comp_cf
## 
  |                                                                       
  |================================================                 |  74%2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3001c(1922 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3002c(1923 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3003c(1924 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3003c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3004(1925 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3004 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3005c(1926 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3005c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3006(1927 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3007c(1928 of 2614)
## 2018-05-16 17:57:00 INFO::Fitting a single group.
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3007c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3009c(1929 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3010c(1930 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3011c(1931 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3012c(1932 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3013(1933 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3013 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3014c(1934 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3015c(1935 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3016(1936 of 2614)
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3024c(1937 of 2614)
## 2018-05-16 17:57:00 INFO::Fitting a single group.
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3024c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3025c(1938 of 2614)
## 2018-05-16 17:57:00 WARNING::Results of protein 1/Rv3025c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:00 INFO::Testing a comparison of protein: 1/Rv3028c(1939 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3029c(1940 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3031(1941 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3031 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3032(1942 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3032 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3032A(1943 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3032A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3033(1944 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3034c(1945 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3034c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3035(1946 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3035 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3036c(1947 of 2614)
## 
  |                                                                       
  |================================================                 |  75%2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3037c(1948 of 2614)
## 2018-05-16 17:57:01 INFO::Fitting a single group.
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3037c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3038c(1949 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3038c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3039c(1950 of 2614)
## 
  |                                                                       
  |=================================================                |  75%2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3040c(1951 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3041c(1952 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3041c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3042c(1953 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3042c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3043c(1954 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3043c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3044(1955 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3045(1956 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3046c(1957 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3048c(1958 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3049c(1959 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3049c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3050c(1960 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3050c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3051c(1961 of 2614)
## 2018-05-16 17:57:01 INFO::Testing a comparison of protein: 1/Rv3052c(1962 of 2614)
## 2018-05-16 17:57:01 WARNING::Results of protein 1/Rv3052c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3053c(1963 of 2614)
## 2018-05-16 17:57:02 INFO::Fitting a single group.
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3053c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3054c(1964 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3054c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3055(1965 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3055 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3057c(1966 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3057c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3058c(1967 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3058c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3059(1968 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3059 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3061c(1969 of 2614)
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3062(1970 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3062 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3068c(1971 of 2614)
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3071(1972 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3071 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3075c(1973 of 2614)
## 
  |                                                                       
  |=================================================                |  76%2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3077(1974 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3077 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3079c(1975 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3079c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3080c(1976 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3080c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3081(1977 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3081 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3082c(1978 of 2614)
## 2018-05-16 17:57:02 INFO::Fitting a single group.
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3082c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3083(1979 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3083 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3084(1980 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3084 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:02 INFO::Testing a comparison of protein: 1/Rv3085(1981 of 2614)
## 2018-05-16 17:57:02 WARNING::Results of protein 1/Rv3085 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3086(1982 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3087(1983 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3087 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3088(1984 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3088 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3089(1985 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3090(1986 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3090 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3091(1987 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3091 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3092c(1988 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3092c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3093c(1989 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3093c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3094c(1990 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3094c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================================================               |  76%2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3096(1991 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3099c(1992 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3101c(1993 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3101c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3102c(1994 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3102c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3104c(1995 of 2614)
## 2018-05-16 17:57:03 INFO::Fitting a single group.
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3104c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3105c(1996 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3106(1997 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3106 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3107c(1998 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3107c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3116(1999 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3116 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================================================               |  77%2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3119(2000 of 2614)
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3120(2001 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3120 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3121(2002 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3121 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3130c(2003 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3130c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:03 INFO::Testing a comparison of protein: 1/Rv3132c(2004 of 2614)
## 2018-05-16 17:57:03 WARNING::Results of protein 1/Rv3132c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3133c(2005 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3134c(2006 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3134c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3136(2007 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3137(2008 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3137 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3139(2009 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3140(2010 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3141(2011 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3141 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3143(2012 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3144c(2013 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3145(2014 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3145 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3146(2015 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3146 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3147(2016 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3148(2017 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3148 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3149(2018 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3150(2019 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3151(2020 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3152(2021 of 2614)
## 2018-05-16 17:57:04 INFO::Fitting a single group.
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3152 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3153(2022 of 2614)
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3154(2023 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3154 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3155(2024 of 2614)
## 2018-05-16 17:57:04 INFO::Fitting a single group.
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3155 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3156(2025 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3156 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==================================================               |  78%2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3157(2026 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3157 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:04 INFO::Testing a comparison of protein: 1/Rv3158(2027 of 2614)
## 2018-05-16 17:57:04 WARNING::Results of protein 1/Rv3158 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3160c(2028 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3160c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3161c(2029 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3164c(2030 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3164c for comparison whole are NA because there are measurements only in group comp_cf
## 
  |                                                                       
  |===================================================              |  78%2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3167c(2031 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3167c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3168(2032 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3168 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3169(2033 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3170(2034 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3170 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3179(2035 of 2614)
## 2018-05-16 17:57:05 INFO::Fitting a single group.
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3179 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3181c(2036 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3181c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3189(2037 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3189 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3190A(2038 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3190A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3190c(2039 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3190c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3193c(2040 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3194c(2041 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3196A(2042 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3197(2043 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3197 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3198A(2044 of 2614)
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3198c(2045 of 2614)
## 2018-05-16 17:57:05 WARNING::Results of protein 1/Rv3198c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:05 INFO::Testing a comparison of protein: 1/Rv3200c(2046 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3203(2047 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3203 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3205c(2048 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3205c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3206c(2049 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3206c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3207c(2050 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3208(2051 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3208 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===================================================              |  79%2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3208A(2052 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3210c(2053 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3210c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3211(2054 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3211 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3212(2055 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3212 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3213c(2056 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3213c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3214(2057 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3215(2058 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3215 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3218(2059 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3218 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3220c(2060 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3220c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3221A(2061 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3221A for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3223c(2062 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3224(2063 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3225c(2064 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3225c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3226c(2065 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3226c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3227(2066 of 2614)
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3228(2067 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3228 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:06 INFO::Testing a comparison of protein: 1/Rv3229c(2068 of 2614)
## 2018-05-16 17:57:06 WARNING::Results of protein 1/Rv3229c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3230c(2069 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3230c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3231c(2070 of 2614)
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3232c(2071 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3232c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |====================================================             |  79%2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3233c(2072 of 2614)
## 2018-05-16 17:57:07 INFO::Fitting a single group.
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3233c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3234c(2073 of 2614)
## 2018-05-16 17:57:07 INFO::Fitting a single group.
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3234c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3237c(2074 of 2614)
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3240c(2075 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3240c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3241c(2076 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3241c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3243c(2077 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3243c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3244c(2078 of 2614)
## 
  |                                                                       
  |====================================================             |  80%2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3245c(2079 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3245c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3246c(2080 of 2614)
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3247c(2081 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3247c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3248c(2082 of 2614)
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3249c(2083 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3249c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3253c(2084 of 2614)
## 2018-05-16 17:57:07 INFO::Fitting a single group.
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3253c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3254(2085 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3254 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3255c(2086 of 2614)
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3256c(2087 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3256c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3257c(2088 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3257c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3259(2089 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3259 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3260c(2090 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3260c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:07 INFO::Testing a comparison of protein: 1/Rv3261(2091 of 2614)
## 2018-05-16 17:57:07 WARNING::Results of protein 1/Rv3261 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3262(2092 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3262 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3264c(2093 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3265c(2094 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3265c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3266c(2095 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3266c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3267(2096 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3268(2097 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3269(2098 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3270(2099 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3271c(2100 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3271c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3272(2101 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3272 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3273(2102 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3274c(2103 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3275c(2104 of 2614)
## 
  |                                                                       
  |====================================================             |  81%2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3276c(2105 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3278c(2106 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3278c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3279c(2107 of 2614)
## 2018-05-16 17:57:08 WARNING::Results of protein 1/Rv3279c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3280(2108 of 2614)
## 2018-05-16 17:57:08 INFO::Testing a comparison of protein: 1/Rv3281(2109 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3282(2110 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3282 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3283(2111 of 2614)
## 
  |                                                                       
  |=====================================================            |  81%2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3284(2112 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3285(2113 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3286c(2114 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3286c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3287c(2115 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3287c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3290c(2116 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3290c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3291c(2117 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3292(2118 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3292 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3293(2119 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3293 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3295(2120 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3296(2121 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3296 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3297(2122 of 2614)
## 2018-05-16 17:57:09 INFO::Fitting a single group.
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3297 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3298c(2123 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3298c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3299c(2124 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3301c(2125 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3302c(2126 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3302c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3303c(2127 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3304(2128 of 2614)
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3305c(2129 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3305c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3306c(2130 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3306c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=====================================================            |  82%2018-05-16 17:57:09 INFO::Testing a comparison of protein: 1/Rv3307(2131 of 2614)
## 2018-05-16 17:57:09 WARNING::Results of protein 1/Rv3307 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3308(2132 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3308 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3309c(2133 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3309c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3310(2134 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3311(2135 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3311 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3312A(2136 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3313c(2137 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3313c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3314c(2138 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3314c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3315c(2139 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3317(2140 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3317 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3318(2141 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3319(2142 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3319 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3321c(2143 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3322c(2144 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3322c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3329(2145 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3329 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3330(2146 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3332(2147 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3332 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3336c(2148 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3336c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3339c(2149 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3340(2150 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3341(2151 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3341 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======================================================           |  82%2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3342(2152 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3342 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3356c(2153 of 2614)
## 2018-05-16 17:57:10 INFO::Testing a comparison of protein: 1/Rv3357(2154 of 2614)
## 2018-05-16 17:57:10 WARNING::Results of protein 1/Rv3357 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3359(2155 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3359 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3360(2156 of 2614)
## 2018-05-16 17:57:11 INFO::Fitting a single group.
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3360 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======================================================           |  83%2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3362c(2157 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3362c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3364c(2158 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3364c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3365c(2159 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3365c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3368c(2160 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3369(2161 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3372(2162 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3373(2163 of 2614)
## 2018-05-16 17:57:11 INFO::Fitting a single group.
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3373 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3375(2164 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3375 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3376(2165 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3376 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3377c(2166 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3377c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3384c(2167 of 2614)
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3384c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3389c(2168 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3390(2169 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3391(2170 of 2614)
## 2018-05-16 17:57:11 INFO::Fitting a single group.
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3391 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3392c(2171 of 2614)
## 2018-05-16 17:57:11 INFO::Testing a comparison of protein: 1/Rv3393(2172 of 2614)
## 2018-05-16 17:57:11 INFO::Fitting a single group.
## 2018-05-16 17:57:11 WARNING::Results of protein 1/Rv3393 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3395A(2173 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3396c(2174 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3399(2175 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3400(2176 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3401(2177 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3404c(2178 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3404c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3405c(2179 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3405c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3407(2180 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3408(2181 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3408 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3409c(2182 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3409c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |======================================================           |  84%2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3410c(2183 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3411c(2184 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3411c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3412(2185 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3412 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3413c(2186 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3417c(2187 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3418c(2188 of 2614)
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3419c(2189 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3419c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3422c(2190 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3422c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3423c(2191 of 2614)
## 
  |                                                                       
  |=======================================================          |  84%2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3432c(2192 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3432c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3433c(2193 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3433c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3435c(2194 of 2614)
## 2018-05-16 17:57:12 WARNING::Results of protein 1/Rv3435c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:12 INFO::Testing a comparison of protein: 1/Rv3436c(2195 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3436c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3437(2196 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3437 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3438(2197 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3438 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3441c(2198 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3441c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3442c(2199 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3443c(2200 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3451(2201 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3452(2202 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3455c(2203 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3455c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3456c(2204 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3457c(2205 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3458c(2206 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3459c(2207 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3460c(2208 of 2614)
## 
  |                                                                       
  |=======================================================          |  85%2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3461c(2209 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3461c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3462c(2210 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3463(2211 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3464(2212 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3465(2213 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3472(2214 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3472 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3477(2215 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3478(2216 of 2614)
## 2018-05-16 17:57:13 INFO::Testing a comparison of protein: 1/Rv3479(2217 of 2614)
## 2018-05-16 17:57:13 WARNING::Results of protein 1/Rv3479 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3480c(2218 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3480c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3482c(2219 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3482c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3483c(2220 of 2614)
## 2018-05-16 17:57:14 INFO::Fitting a single group.
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3483c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3484(2221 of 2614)
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3485c(2222 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3485c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3487c(2223 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3487c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3488(2224 of 2614)
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3489(2225 of 2614)
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3490(2226 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3490 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3492c(2227 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3492c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3493c(2228 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3493c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3494c(2229 of 2614)
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3495c(2230 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3495c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3496c(2231 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3496c for comparison whole are NA because there are measurements only in group comp_cf
## 
  |                                                                       
  |========================================================         |  85%2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3497c(2232 of 2614)
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3498c(2233 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3498c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3499c(2234 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3499c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |========================================================         |  86%2018-05-16 17:57:14 INFO::Testing a comparison of protein: 1/Rv3500c(2235 of 2614)
## 2018-05-16 17:57:14 WARNING::Results of protein 1/Rv3500c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3501c(2236 of 2614)
## 2018-05-16 17:57:15 INFO::Fitting a single group.
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3501c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3502c(2237 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3503c(2238 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3504(2239 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3504 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3505(2240 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3505 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3509c(2241 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3510c(2242 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3515c(2243 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3515c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3516(2244 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3516 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3517(2245 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3517 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3518c(2246 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3519(2247 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3519 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3520c(2248 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3522(2249 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3522 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3523(2250 of 2614)
## 2018-05-16 17:57:15 INFO::Fitting a single group.
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3523 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3524(2251 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3526(2252 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3528c(2253 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3528c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3529c(2254 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3529c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3534c(2255 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3534c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3535c(2256 of 2614)
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3536c(2257 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3536c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:15 INFO::Testing a comparison of protein: 1/Rv3537(2258 of 2614)
## 2018-05-16 17:57:15 WARNING::Results of protein 1/Rv3537 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3540c(2259 of 2614)
## 2018-05-16 17:57:16 INFO::Fitting a single group.
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3540c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3542c(2260 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3542c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3543c(2261 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3543c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |========================================================         |  87%2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3544c(2262 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3544c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3545c(2263 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3546(2264 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3547(2265 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3548c(2266 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3548c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3550(2267 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3550 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3554(2268 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3554 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3556c(2269 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3559c(2270 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3559c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3560c(2271 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3560c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3561(2272 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3561 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=========================================================        |  87%2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3562(2273 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3562 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3564(2274 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3564 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3566c(2275 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3568c(2276 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3569c(2277 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3570c(2278 of 2614)
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3571(2279 of 2614)
## 2018-05-16 17:57:16 WARNING::Results of protein 1/Rv3571 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:16 INFO::Testing a comparison of protein: 1/Rv3572(2280 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3573c(2281 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3573c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3574(2282 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3574 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3575c(2283 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3576(2284 of 2614)
## 2018-05-16 17:57:17 INFO::Fitting a single group.
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3576 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3577(2285 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3577 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3579c(2286 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3579c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3580c(2287 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3580c for comparison whole are NA because there are measurements only in group delta_cf
## 
  |                                                                       
  |=========================================================        |  88%2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3581c(2288 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3581c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3582c(2289 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3582c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3583c(2290 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3584(2291 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3586(2292 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3586 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3587c(2293 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3588c(2294 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3589(2295 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3589 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3591c(2296 of 2614)
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3591c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3592(2297 of 2614)
## 2018-05-16 17:57:17 INFO::Testing a comparison of protein: 1/Rv3593(2298 of 2614)
## 2018-05-16 17:57:17 INFO::Fitting a single group.
## 2018-05-16 17:57:17 WARNING::Results of protein 1/Rv3593 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3596c(2299 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3597c(2300 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3598c(2301 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3600c(2302 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3600c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3601c(2303 of 2614)
## 2018-05-16 17:57:18 INFO::Fitting a single group.
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3601c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3602c(2304 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3602c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3604c(2305 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3606c(2306 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3606c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3607c(2307 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3608c(2308 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3608c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3609c(2309 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3610c(2310 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3610c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3614c(2311 of 2614)
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3615c(2312 of 2614)
## 
  |                                                                       
  |==========================================================       |  88%2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3616c(2313 of 2614)
## 
  |                                                                       
  |==========================================================       |  89%2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3617(2314 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3617 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3618(2315 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3618 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3623(2316 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3623 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3624c(2317 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3624c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3625c(2318 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3625c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3626c(2319 of 2614)
## 2018-05-16 17:57:18 WARNING::Results of protein 1/Rv3626c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:18 INFO::Testing a comparison of protein: 1/Rv3627c(2320 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3628(2321 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3631(2322 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3631 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3632(2323 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3632 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3633(2324 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3633 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3634c(2325 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3644c(2326 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3644c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3645(2327 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3645 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3646c(2328 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3647c(2329 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3647c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3648c(2330 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3651(2331 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3651 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3661(2332 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3661 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3662c(2333 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3662c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3663c(2334 of 2614)
## 2018-05-16 17:57:19 INFO::Fitting a single group.
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3663c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3666c(2335 of 2614)
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3667(2336 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3667 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3669(2337 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3669 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3670(2338 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3670 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3671c(2339 of 2614)
## 
  |                                                                       
  |==========================================================       |  90%2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3672c(2340 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3672c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3673c(2341 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3673c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:19 INFO::Testing a comparison of protein: 1/Rv3674c(2342 of 2614)
## 2018-05-16 17:57:19 WARNING::Results of protein 1/Rv3674c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3675(2343 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3675 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3676(2344 of 2614)
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3677c(2345 of 2614)
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3678A(2346 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3678A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3678c(2347 of 2614)
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3679(2348 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3679 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3680(2349 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3680 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3682(2350 of 2614)
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3683(2351 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3683 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3684(2352 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3684 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===========================================================      |  90%2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3685c(2353 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3685c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3687c(2354 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3687c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3688c(2355 of 2614)
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3690(2356 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3690 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3691(2357 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3691 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3692(2358 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3692 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3693(2359 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3693 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:20 INFO::Testing a comparison of protein: 1/Rv3695(2360 of 2614)
## 2018-05-16 17:57:20 WARNING::Results of protein 1/Rv3695 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3696c(2361 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3697A(2362 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3697A for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3699(2363 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3700c(2364 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3700c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3701c(2365 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3701c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===========================================================      |  91%2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3702c(2366 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3702c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3703c(2367 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3703c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3705c(2368 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3708c(2369 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3709c(2370 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3710(2371 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3713(2372 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3713 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3715c(2373 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3715c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3716c(2374 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3717(2375 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3718c(2376 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3719(2377 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3719 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3720(2378 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3721c(2379 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3721c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3722c(2380 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3723(2381 of 2614)
## 2018-05-16 17:57:21 INFO::Testing a comparison of protein: 1/Rv3726(2382 of 2614)
## 2018-05-16 17:57:21 WARNING::Results of protein 1/Rv3726 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3729(2383 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3729 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3730c(2384 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3730c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3731(2385 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3731 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3732(2386 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3732 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3734c(2387 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3734c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3736(2388 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3736 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3737(2389 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3737 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3744(2390 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3744 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3747(2391 of 2614)
## 
  |                                                                       
  |===========================================================      |  92%2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3753c(2392 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3753c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |============================================================     |  92%2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3754(2393 of 2614)
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3755c(2394 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3755c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3758c(2395 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3758c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3759c(2396 of 2614)
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3761c(2397 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3761c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3762c(2398 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3762c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3763(2399 of 2614)
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3764c(2400 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3764c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3765c(2401 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3765c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3766(2402 of 2614)
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3767c(2403 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3767c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:22 INFO::Testing a comparison of protein: 1/Rv3768(2404 of 2614)
## 2018-05-16 17:57:22 WARNING::Results of protein 1/Rv3768 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3772(2405 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3772 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3773c(2406 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3773c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3774(2407 of 2614)
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3775(2408 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3775 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3777(2409 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3777 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3778c(2410 of 2614)
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3779(2411 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3779 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3780(2412 of 2614)
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3781(2413 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3781 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3782(2414 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3782 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3784(2415 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3784 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3786c(2416 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3786c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3787c(2417 of 2614)
## 2018-05-16 17:57:23 INFO::Fitting a single group.
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3787c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |============================================================     |  93%2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3788(2418 of 2614)
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3790(2419 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3790 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3791(2420 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3791 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3792(2421 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3792 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:23 INFO::Testing a comparison of protein: 1/Rv3793(2422 of 2614)
## 2018-05-16 17:57:23 WARNING::Results of protein 1/Rv3793 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3794(2423 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3795(2424 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3795 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3796(2425 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3796 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3797(2426 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3797 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3799c(2427 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3799c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3800c(2428 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3801c(2429 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3802c(2430 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3803c(2431 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3804c(2432 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3805c(2433 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3805c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================================================    |  93%2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3806c(2434 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3806c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3808c(2435 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3808c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3809c(2436 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3809c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3813c(2437 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3813c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3814c(2438 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3814c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3815c(2439 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3815c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3816c(2440 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3816c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3817(2441 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3817 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3818(2442 of 2614)
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3819(2443 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3819 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:24 INFO::Testing a comparison of protein: 1/Rv3820c(2444 of 2614)
## 2018-05-16 17:57:24 WARNING::Results of protein 1/Rv3820c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=============================================================    |  94%2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3822(2445 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3824c(2446 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3824c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3825c(2447 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3825c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3826(2448 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3826 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3834c(2449 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3834c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3835(2450 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3836(2451 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3836 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3837c(2452 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3837c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3838c(2453 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3838c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3841(2454 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3842c(2455 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3842c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3843c(2456 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3843c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3846(2457 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3849(2458 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3850(2459 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3850 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3852(2460 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3853(2461 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3854c(2462 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3854c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3855(2463 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3855 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3856c(2464 of 2614)
## 2018-05-16 17:57:25 WARNING::Results of protein 1/Rv3856c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3858c(2465 of 2614)
## 2018-05-16 17:57:25 INFO::Testing a comparison of protein: 1/Rv3859c(2466 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3860(2467 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3860 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3863(2468 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3864(2469 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3865(2470 of 2614)
## 
  |                                                                       
  |=============================================================    |  95%2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3866(2471 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3866 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3867(2472 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3868(2473 of 2614)
## 
  |                                                                       
  |==============================================================   |  95%2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3869(2474 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3870(2475 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3870 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3871(2476 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3871 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3872(2477 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3873(2478 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3873 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3874(2479 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3875(2480 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3876(2481 of 2614)
## 2018-05-16 17:57:26 WARNING::Results of protein 1/Rv3876 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3878(2482 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3879c(2483 of 2614)
## 2018-05-16 17:57:26 INFO::Testing a comparison of protein: 1/Rv3880c(2484 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3881c(2485 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3882c(2486 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3882c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3883c(2487 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3883c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3884c(2488 of 2614)
## 2018-05-16 17:57:27 INFO::Fitting a single group.
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3884c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3885c(2489 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3885c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3886c(2490 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3887c(2491 of 2614)
## 2018-05-16 17:57:27 INFO::Fitting a single group.
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3887c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3888c(2492 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3888c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3890c(2493 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3891c(2494 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3894c(2495 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3894c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3895c(2496 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3895c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |==============================================================   |  96%2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3902c(2497 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3902c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3907c(2498 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3907c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3908(2499 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3908 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3909(2500 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3909 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3910(2501 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3913(2502 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3914(2503 of 2614)
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3915(2504 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3915 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3916c(2505 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3916c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:27 INFO::Testing a comparison of protein: 1/Rv3917c(2506 of 2614)
## 2018-05-16 17:57:27 WARNING::Results of protein 1/Rv3917c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3918c(2507 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3918c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3919c(2508 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3919c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3920c(2509 of 2614)
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3921c(2510 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3921c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3922c(2511 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3922c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3923c(2512 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3923c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 1/Rv3924c(2513 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 1/Rv3924c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================================================  |  96%2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0073/Rv2564(2514 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0073/Rv2564 for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0107c/Rv1415(2515 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0107c/Rv1415 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0327c/Rv3240c(2516 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0327c/Rv3240c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0386/Rv0890c(2517 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0386/Rv0890c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0469/Rv0645c(2518 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0469/Rv0645c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0593/Rv0173(2519 of 2614)
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0645c/Rv0469(2520 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv0645c/Rv0469 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv0893c/Rv0281(2521 of 2614)
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1039c/Rv0387c(2522 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv1039c/Rv0387c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================================================  |  97%2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1135c/Rv0878c(2523 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv1135c/Rv0878c for comparison whole
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1181/Rv2940c(2524 of 2614)
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1253/Rv3366(2525 of 2614)
## 2018-05-16 17:57:28 INFO::Fitting a single group.
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv1253/Rv3366 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1281c/Rv2713(2526 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv1281c/Rv2713 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1320c/Rv1318c(2527 of 2614)
## 2018-05-16 17:57:28 WARNING::Results of protein 2/Rv1320c/Rv1318c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:28 INFO::Testing a comparison of protein: 2/Rv1361c/Rv1196(2528 of 2614)
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1467c/Rv0244c(2529 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1467c/Rv0244c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1526c/Rv1524(2530 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1526c/Rv1524 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1529/Rv1521(2531 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1529/Rv1521 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1630/Rv1564c(2532 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1630/Rv1564c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1661/Rv2048c(2533 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1661/Rv2048c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1662/Rv2048c(2534 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1662/Rv2048c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1674c/Rv3295(2535 of 2614)
## 2018-05-16 17:57:29 INFO::Fitting a single group.
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1674c/Rv3295 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1695/Rv3285(2536 of 2614)
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1729c/Rv0725c(2537 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1729c/Rv0725c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1736c/Rv1161(2538 of 2614)
## 2018-05-16 17:57:29 INFO::Fitting a single group.
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1736c/Rv1161 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1736c/Rv1164(2539 of 2614)
## 2018-05-16 17:57:29 INFO::Fitting a single group.
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1736c/Rv1164 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1760/Rv1595(2540 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1760/Rv1595 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1771/Rv0706(2541 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1771/Rv0706 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1797/Rv0667(2542 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1797/Rv0667 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1821/Rv3240c(2543 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1821/Rv3240c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv1945/Rv1148c(2544 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv1945/Rv1148c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv2048c/Rv1661(2545 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv2048c/Rv1661 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv2115c/Rv0435c(2546 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv2115c/Rv0435c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:29 INFO::Testing a comparison of protein: 2/Rv2223c/Rv2224c(2547 of 2614)
## 2018-05-16 17:57:29 WARNING::Results of protein 2/Rv2223c/Rv2224c for comparison whole are NA because there are measurements only in group comp_cf
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2284/Rv1426c(2548 of 2614)
## 2018-05-16 17:57:30 INFO::Fitting a single group.
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2284/Rv1426c for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===============================================================  |  98%2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2346c/Rv1793(2549 of 2614)
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2351c/Rv2350c(2550 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2351c/Rv2350c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2564/Rv0073(2551 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2564/Rv0073 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2590/Rv0101(2552 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2590/Rv0101 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2643/Rv3120(2553 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2643/Rv3120 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |================================================================ |  98%2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2650c/Rv1576c(2554 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2650c/Rv1576c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2703/Rv2710(2555 of 2614)
## 2018-05-16 17:57:30 INFO::Fitting a single group.
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2703/Rv2710 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2828c/Rv2825c(2556 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2828c/Rv2825c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2931/Rv2932(2557 of 2614)
## 2018-05-16 17:57:30 INFO::Fitting a single group.
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2931/Rv2932 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2932/Rv2931(2558 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2932/Rv2931 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2933/Rv2932(2559 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2933/Rv2932 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2940c/Rv1181(2560 of 2614)
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2940c/Rv1527c(2561 of 2614)
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2947c/Rv2048c(2562 of 2614)
## 2018-05-16 17:57:30 INFO::Fitting a single group.
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2947c/Rv2048c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2949c/Rv3436c(2563 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2949c/Rv3436c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2953/Rv2449c(2564 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2953/Rv2449c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2956/Rv1513(2565 of 2614)
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2956/Rv1513 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2962c/Rv3596c(2566 of 2614)
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv2974c/Rv1213(2567 of 2614)
## 2018-05-16 17:57:30 INFO::Fitting a single group.
## 2018-05-16 17:57:30 WARNING::Results of protein 2/Rv2974c/Rv1213 for comparison whole
## 2018-05-16 17:57:30 INFO::Testing a comparison of protein: 2/Rv3022A/Rv0285(2568 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3034c/Rv0777(2569 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3049c/Rv0892(2570 of 2614)
## 2018-05-16 17:57:31 INFO::Fitting a single group.
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3049c/Rv0892 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3083/Rv0565c(2571 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3083/Rv0565c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3083/Rv3854c(2572 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3083/Rv3854c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3117/Rv0815c(2573 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3118/Rv0814c(2574 of 2614)
## 
  |                                                                       
  |================================================================ |  99%2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3132c/Rv2027c(2575 of 2614)
## 2018-05-16 17:57:31 INFO::Fitting a single group.
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3132c/Rv2027c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3182/Rv2022c(2576 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3182/Rv2022c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3375/Rv2838c(2577 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3375/Rv2838c for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3392c/Rv0470c(2578 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3392c/Rv0470c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3392c/Rv0642c(2579 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3399/Rv0145(2580 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3399/Rv0145 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3417c/Rv0440(2581 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3478/Rv1361c(2582 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3480c/Rv2285(2583 of 2614)
## 2018-05-16 17:57:31 INFO::Fitting a single group.
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3480c/Rv2285 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3515c/Rv3513c(2584 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3515c/Rv3513c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3533c/Rv3159c(2585 of 2614)
## 2018-05-16 17:57:31 INFO::Fitting a single group.
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3533c/Rv3159c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3596c/Rv0384c(2586 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3692/Rv1479(2587 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3692/Rv1479 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3767c/Rv1729c(2588 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3767c/Rv1729c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3804c/Rv1886c(2589 of 2614)
## 2018-05-16 17:57:31 INFO::Testing a comparison of protein: 2/Rv3825c/Rv1181(2590 of 2614)
## 2018-05-16 17:57:31 WARNING::Results of protein 2/Rv3825c/Rv1181 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 2/Rv3825c/Rv1527c(2591 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 2/Rv3825c/Rv1527c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 2/Rv3826/Rv2941(2592 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 2/Rv3826/Rv2941 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 2/Rv3833/Rv1925(2593 of 2614)
## 
  |                                                                       
  |=================================================================|  99%2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv0644c/Rv0643c/Rv0470c(2594 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv0644c/Rv0643c/Rv0470c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv0748/Rv0277A/Rv3393(2595 of 2614)
## 2018-05-16 17:57:32 INFO::Fitting a single group.
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv0748/Rv0277A/Rv3393 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv1131/Rv0896/Rv0889c(2596 of 2614)
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv1320c/Rv1319c/Rv1318c(2597 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv1320c/Rv1319c/Rv1318c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv1361c/Rv1196/Rv3478(2598 of 2614)
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv1529/Rv1521/Rv2930(2599 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv1529/Rv1521/Rv2930 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv2015c/Rv1765c/Rv3031(2600 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv2015c/Rv1765c/Rv3031 for comparison whole are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |=================================================================| 100%2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv2351c/Rv2350c/Rv2349c(2601 of 2614)
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv2933/Rv2932/Rv2931(2602 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv2933/Rv2932/Rv2931 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv2941/Rv1529/Rv1521(2603 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv2941/Rv1529/Rv1521 for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv3121/Rv2266/Rv0212c(2604 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv3121/Rv2266/Rv0212c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv3392c/Rv0503c/Rv0470c(2605 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv3392c/Rv0503c/Rv0470c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv3392c/Rv0644c/Rv0643c(2606 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv3392c/Rv0644c/Rv0643c for comparison whole are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv3767c/Rv0726c/Rv0146(2607 of 2614)
## 2018-05-16 17:57:32 WARNING::Results of protein 3/Rv3767c/Rv0726c/Rv0146 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:32 INFO::Testing a comparison of protein: 3/Rv3798/Rv1313c/Rv2984(2608 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 3/Rv3825c/Rv2940c/Rv1181(2609 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 4/Rv2932/Rv2931/Rv2823c/Rv3566c(2610 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 4/Rv3140/Rv1297/Rv0549c/Rv2308(2611 of 2614)
## 2018-05-16 17:57:33 WARNING::Results of protein 4/Rv3140/Rv1297/Rv0549c/Rv2308 for comparison whole are NA because there are measurements only in group delta_cf
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 4/Rv3826/Rv2941/Rv1529/Rv1521(2612 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 5/Rv3619c/Rv2346c/Rv1793/Rv1198/Rv1037c(2613 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 5/Rv3620c/Rv2347c/Rv1792/Rv1197/Rv1038c(2614 of 2614)
## 
## 2018-05-16 17:57:33 INFO::Comparisons for all proteins are finished.
## 2018-05-16 17:57:33 INFO::Adjusted p-values are calculated.
## 2018-05-16 17:57:33 INFO::Group comparison is complete.
second_comparison <- t(as.matrix(comparison[2, ]))
rownames(second_comparison) <- "cf"
second_msstats_comparison <- MSstats::groupComparison(contrast.matrix=second_comparison,
                                                     data=msstats_quant)
## 2018-05-16 17:57:33 INFO::MSstats - starting groupComparison().
## 2018-05-16 17:57:33 INFO::Some important variables: labeled=FALSE scopeOfBioReplication=expanded
## 2018-05-16 17:57:33 INFO::Case control design of experiment is acceptable.
## 2018-05-16 17:57:33 INFO::Starting inference methods.
## 
  |                                                                       
  |                                                                 |   0%2018-05-16 17:57:33 INFO::Testing a comparison of protein: 1/DECOY_Rv3047c_UNMAPPED(1 of 2614)
## 2018-05-16 17:57:33 INFO::Fitting a single group.
## 2018-05-16 17:57:33 WARNING::Results of protein 1/DECOY_Rv3047c_UNMAPPED for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 1/Rv0001(2 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 1/Rv0002(3 of 2614)
## 2018-05-16 17:57:33 INFO::Testing a comparison of protein: 1/Rv0003(4 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0005(5 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0006(6 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0007(7 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0008c(8 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0009(9 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0010c(10 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0011c(11 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0012(12 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0014c(13 of 2614)
## 
  |                                                                       
  |                                                                 |   1%2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0015c(14 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0016c(15 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0017c(16 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0018c(17 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0019c(18 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0020c(19 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0023(20 of 2614)
## 
  |                                                                       
  |=                                                                |   1%2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0025(21 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0027(22 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0029(23 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0032(24 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0034(25 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0035(26 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0036c(27 of 2614)
## 2018-05-16 17:57:34 INFO::Testing a comparison of protein: 1/Rv0037c(28 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0038(29 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0040c(30 of 2614)
## 2018-05-16 17:57:35 WARNING::Results of protein 1/Rv0040c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0041(31 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0042c(32 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0043c(33 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0044c(34 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0045c(35 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0046c(36 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0047c(37 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0048c(38 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0050(39 of 2614)
## 
  |                                                                       
  |=                                                                |   2%2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0051(40 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0052(41 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0053(42 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0054(43 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0055(44 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0056(45 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0058(46 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0059(47 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0060(48 of 2614)
## 2018-05-16 17:57:35 INFO::Testing a comparison of protein: 1/Rv0061c(49 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0062(50 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0063(51 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0066c(52 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0068(53 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0069c(54 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0070c(55 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0072(56 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0073(57 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0074(58 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0075(59 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0077c(60 of 2614)
## 
  |                                                                       
  |==                                                               |   2%2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0078(61 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0078A(62 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0079(63 of 2614)
## 2018-05-16 17:57:36 INFO::Fitting a single group.
## 2018-05-16 17:57:36 WARNING::Results of protein 1/Rv0079 for comparison cf
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0081(64 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0087(65 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 
  |                                                                       
  |==                                                               |   3%2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0088(66 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0091(67 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0092(68 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0097(69 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0098(70 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0099(71 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0101(72 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0103c(73 of 2614)
## 2018-05-16 17:57:36 INFO::Testing a comparison of protein: 1/Rv0107c(74 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0108c(75 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0116c(76 of 2614)
## 2018-05-16 17:57:37 WARNING::Results of protein 1/Rv0116c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0117(77 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0118c(78 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0119(79 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0120c(80 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0121c(81 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0123(82 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0125(83 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0126(84 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0127(85 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0129c(86 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0130(87 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0131c(88 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0134(89 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0135c(90 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0136(91 of 2614)
## 
  |                                                                       
  |==                                                               |   4%2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0137c(92 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0138(93 of 2614)
## 2018-05-16 17:57:37 INFO::Fitting a single group.
## 2018-05-16 17:57:37 WARNING::Results of protein 1/Rv0138 for comparison cf
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0139(94 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0140(95 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0141c(96 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0144(97 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0145(98 of 2614)
## 2018-05-16 17:57:37 INFO::Testing a comparison of protein: 1/Rv0146(99 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0147(100 of 2614)
## 
  |                                                                       
  |===                                                              |   4%2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0148(101 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0149(102 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0153c(103 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0154c(104 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0155(105 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0157(106 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0157A(107 of 2614)
## 2018-05-16 17:57:38 WARNING::Results of protein 1/Rv0157A for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0158(108 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0161(109 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0162c(110 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0163(111 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0164(112 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0166(113 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0169(114 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0170(115 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0171(116 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0172(117 of 2614)
## 
  |                                                                       
  |===                                                              |   5%2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0173(118 of 2614)
## 2018-05-16 17:57:38 INFO::Testing a comparison of protein: 1/Rv0174(119 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0175(120 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0176(121 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0177(122 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0178(123 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0179c(124 of 2614)
## 2018-05-16 17:57:39 WARNING::Results of protein 1/Rv0179c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0180c(125 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0181c(126 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0182c(127 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0183(128 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0184(129 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0185(130 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0186(131 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0186A(132 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0187(133 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0189c(134 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0190(135 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0196(136 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0198c(137 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0199(138 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0200(139 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0201c(140 of 2614)
## 
  |                                                                       
  |====                                                             |   5%2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0202c(141 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0203(142 of 2614)
## 2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0204c(143 of 2614)
## 2018-05-16 17:57:39 INFO::Fitting a single group.
## 2018-05-16 17:57:39 WARNING::Results of protein 1/Rv0204c for comparison cf
## 
  |                                                                       
  |====                                                             |   6%2018-05-16 17:57:39 INFO::Testing a comparison of protein: 1/Rv0206c(144 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0207c(145 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0208c(146 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0211(147 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0214(148 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0215c(149 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0216(150 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0217c(151 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0220(152 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0221(153 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0222(154 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0223c(155 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0226c(156 of 2614)
## 2018-05-16 17:57:40 INFO::Fitting a single group.
## 2018-05-16 17:57:40 WARNING::Results of protein 1/Rv0226c for comparison cf
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0227c(157 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0229c(158 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0230c(159 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0231(160 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0232(161 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0233(162 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0234c(163 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0237(164 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0238(165 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0239(166 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0241c(167 of 2614)
## 2018-05-16 17:57:40 INFO::Testing a comparison of protein: 1/Rv0242c(168 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0243(169 of 2614)
## 
  |                                                                       
  |====                                                             |   7%2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0244c(170 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0245(171 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0247c(172 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0248c(173 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0249c(174 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0250c(175 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0255c(176 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0256c(177 of 2614)
## 2018-05-16 17:57:41 INFO::Fitting a single group.
## 2018-05-16 17:57:41 WARNING::Results of protein 1/Rv0256c for comparison cf
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0262c(178 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0263c(179 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0265c(180 of 2614)
## 
  |                                                                       
  |=====                                                            |   7%2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0266c(181 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0269c(182 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0270(183 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0271c(184 of 2614)
## 2018-05-16 17:57:41 INFO::Testing a comparison of protein: 1/Rv0272c(185 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0274(186 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0276(187 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0281(188 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0282(189 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0283(190 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0284(191 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0285(192 of 2614)
## 2018-05-16 17:57:42 WARNING::Results of protein 1/Rv0285 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0286(193 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0287(194 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0288(195 of 2614)
## 2018-05-16 17:57:42 WARNING::Results of protein 1/Rv0288 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0289(196 of 2614)
## 
  |                                                                       
  |=====                                                            |   8%2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0290(197 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0291(198 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0292(199 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0293c(200 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0294(201 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0295c(202 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0296c(203 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0298(204 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0300(205 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0301(206 of 2614)
## 2018-05-16 17:57:42 INFO::Testing a comparison of protein: 1/Rv0303(207 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0307c(208 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0308(209 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0309(210 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0310c(211 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0311(212 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0312(213 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0313(214 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0315(215 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0316(216 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0317c(217 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0321(218 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0324(219 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0328(220 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0329c(221 of 2614)
## 
  |                                                                       
  |======                                                           |   8%2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0331(222 of 2614)
## 
  |                                                                       
  |======                                                           |   9%2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0332(223 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0333(224 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0334(225 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0337c(226 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0338c(227 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0339c(228 of 2614)
## 2018-05-16 17:57:43 INFO::Testing a comparison of protein: 1/Rv0340(229 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0341(230 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0342(231 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0343(232 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0344c(233 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0347(234 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0348(235 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0349(236 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0350(237 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0351(238 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0352(239 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0353(240 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0356c(241 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0357c(242 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0360c(243 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0361(244 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0363c(245 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0365c(246 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0367c(247 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0376c(248 of 2614)
## 
  |                                                                       
  |======                                                           |  10%2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0379(249 of 2614)
## 2018-05-16 17:57:44 INFO::Testing a comparison of protein: 1/Rv0382c(250 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0383c(251 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0384c(252 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0386(253 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0389(254 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0390(255 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0391(256 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0392c(257 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0394c(258 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0397A(259 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0398c(260 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0400c(261 of 2614)
## 
  |                                                                       
  |=======                                                          |  10%2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0404(262 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0405(263 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0406c(264 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0407(265 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0408(266 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0409(267 of 2614)
## 2018-05-16 17:57:45 INFO::Testing a comparison of protein: 1/Rv0410c(268 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0411c(269 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0412c(270 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0413(271 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0414c(272 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0415(273 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0417(274 of 2614)
## 
  |                                                                       
  |=======                                                          |  11%2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0418(275 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0419(276 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0421c(277 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0422c(278 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0423c(279 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0424c(280 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0425c(281 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0426c(282 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0427c(283 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0428c(284 of 2614)
## 2018-05-16 17:57:46 INFO::Testing a comparison of protein: 1/Rv0430(285 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0431(286 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0432(287 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0433(288 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0434(289 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0435c(290 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0436c(291 of 2614)
## 2018-05-16 17:57:47 INFO::Fitting a single group.
## 2018-05-16 17:57:47 WARNING::Results of protein 1/Rv0436c for comparison cf
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0437c(292 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0438c(293 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0439c(294 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0440(295 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0441c(296 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0442c(297 of 2614)
## 2018-05-16 17:57:47 WARNING::Results of protein 1/Rv0442c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0443(298 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0444c(299 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0445c(300 of 2614)
## 
  |                                                                       
  |=======                                                          |  12%2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0450c(301 of 2614)
## 
  |                                                                       
  |========                                                         |  12%2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0455c(302 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0456c(303 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0457c(304 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0458(305 of 2614)
## 2018-05-16 17:57:47 INFO::Testing a comparison of protein: 1/Rv0459(306 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0461(307 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0462(308 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0464c(309 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0466(310 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0467(311 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0468(312 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0469(313 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0470c(314 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0472c(315 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0473(316 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0474(317 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0475(318 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0477(319 of 2614)
## 2018-05-16 17:57:48 WARNING::Results of protein 1/Rv0477 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0478(320 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0479c(321 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0480c(322 of 2614)
## 2018-05-16 17:57:48 INFO::Testing a comparison of protein: 1/Rv0481c(323 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0482(324 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0483(325 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0484c(326 of 2614)
## 
  |                                                                       
  |========                                                         |  13%2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0485(327 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0486(328 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0487(329 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0489(330 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0490(331 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0491(332 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0492c(333 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0493c(334 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0495c(335 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0496(336 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0497(337 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0498(338 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0499(339 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0500(340 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0500A(341 of 2614)
## 
  |                                                                       
  |=========                                                        |  13%2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0501(342 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0502(343 of 2614)
## 2018-05-16 17:57:49 INFO::Testing a comparison of protein: 1/Rv0503c(344 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0504c(345 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0505c(346 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0508(347 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0509(348 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0510(349 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0511(350 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0512(351 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0513(352 of 2614)
## 
  |                                                                       
  |=========                                                        |  14%2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0516c(353 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0517(354 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0518(355 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0519c(356 of 2614)
## 2018-05-16 17:57:50 INFO::Fitting a single group.
## 2018-05-16 17:57:50 WARNING::Results of protein 1/Rv0519c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0523c(357 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0524(358 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0525(359 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0526(360 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0528(361 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0529(362 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0530(363 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0530A(364 of 2614)
## 2018-05-16 17:57:50 INFO::Testing a comparison of protein: 1/Rv0531(365 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0533c(366 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0536(367 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0537c(368 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0538(369 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0539(370 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0540(371 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0542c(372 of 2614)
## 2018-05-16 17:57:51 INFO::Fitting a single group.
## 2018-05-16 17:57:51 WARNING::Results of protein 1/Rv0542c for comparison cf
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0543c(373 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0544c(374 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0545c(375 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0546c(376 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0547c(377 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0548c(378 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0550c(379 of 2614)
## 
  |                                                                       
  |=========                                                        |  15%2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0551c(380 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0552(381 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0553(382 of 2614)
## 
  |                                                                       
  |==========                                                       |  15%2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0554(383 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0555(384 of 2614)
## 2018-05-16 17:57:51 INFO::Testing a comparison of protein: 1/Rv0556(385 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0558(386 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0559c(387 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0560c(388 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0561c(389 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0562(390 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0563(391 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0564c(392 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0565c(393 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0566c(394 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0567(395 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0568(396 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0569(397 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0571c(398 of 2614)
## 2018-05-16 17:57:52 INFO::Fitting a single group.
## 2018-05-16 17:57:52 WARNING::Results of protein 1/Rv0571c for comparison cf
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0576(399 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0577(400 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0578c(401 of 2614)
## 2018-05-16 17:57:52 INFO::Fitting a single group.
## 2018-05-16 17:57:52 WARNING::Results of protein 1/Rv0578c for comparison cf
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0580c(402 of 2614)
## 2018-05-16 17:57:52 INFO::Testing a comparison of protein: 1/Rv0581(403 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0582(404 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0583c(405 of 2614)
## 
  |                                                                       
  |==========                                                       |  16%2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0586(406 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0595c(407 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0596c(408 of 2614)
## 2018-05-16 17:57:53 INFO::Fitting a single group.
## 2018-05-16 17:57:53 WARNING::Results of protein 1/Rv0596c for comparison cf
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0597c(409 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0598c(410 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0599c(411 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0604(412 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:53 WARNING::Results of protein 1/Rv0604 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0609(413 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0610c(414 of 2614)
## 2018-05-16 17:57:53 INFO::Fitting a single group.
## 2018-05-16 17:57:53 WARNING::Results of protein 1/Rv0610c for comparison cf
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0613c(415 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0616A(416 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0617(417 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0623(418 of 2614)
## 2018-05-16 17:57:53 INFO::Fitting a single group.
## 2018-05-16 17:57:53 WARNING::Results of protein 1/Rv0623 for comparison cf
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0626(419 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0628c(420 of 2614)
## 2018-05-16 17:57:53 INFO::Fitting a single group.
## 2018-05-16 17:57:53 WARNING::Results of protein 1/Rv0628c for comparison cf
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0629c(421 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0630c(422 of 2614)
## 
  |                                                                       
  |===========                                                      |  16%2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0631c(423 of 2614)
## 2018-05-16 17:57:53 INFO::Testing a comparison of protein: 1/Rv0632c(424 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0633c(425 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0634A(426 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0634B(427 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0634c(428 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0635(429 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0636(430 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0637(431 of 2614)
## 
  |                                                                       
  |===========                                                      |  17%2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0638(432 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0639(433 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0640(434 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0641(435 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0642c(436 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0643c(437 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0644c(438 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0645c(439 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0646c(440 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0647c(441 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0651(442 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0652(443 of 2614)
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0653c(444 of 2614)
## 2018-05-16 17:57:54 INFO::Fitting a single group.
## 2018-05-16 17:57:54 WARNING::Results of protein 1/Rv0653c for comparison cf
## 2018-05-16 17:57:54 INFO::Testing a comparison of protein: 1/Rv0654(445 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0655(446 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0660c(447 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0667(448 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0668(449 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0669c(450 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0670(451 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0671(452 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0672(453 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0673(454 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0675(455 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0676c(456 of 2614)
## 2018-05-16 17:57:55 WARNING::Results of protein 1/Rv0676c for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0677c(457 of 2614)
## 2018-05-16 17:57:55 WARNING::Results of protein 1/Rv0677c for comparison cf are NA because there are no measurements in both conditions.
## 
  |                                                                       
  |===========                                                      |  18%2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0678(458 of 2614)
## 2018-05-16 17:57:55 WARNING::Results of protein 1/Rv0678 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0679c(459 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0680c(460 of 2614)
## 2018-05-16 17:57:55 WARNING::Results of protein 1/Rv0680c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0681(461 of 2614)
## 2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0682(462 of 2614)
## 
  |                                                                       
  |============                                                     |  18%2018-05-16 17:57:55 INFO::Testing a comparison of protein: 1/Rv0683(463 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0684(464 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0685(465 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0686(466 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0687(467 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0688(468 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0690c(469 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0694(470 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0695(471 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0696(472 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0700(473 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0701(474 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0702(475 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0703(476 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0704(477 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0705(478 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0706(479 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0707(480 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0708(481 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0709(482 of 2614)
## 2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0710(483 of 2614)
## 
  |                                                                       
  |============                                                     |  19%2018-05-16 17:57:56 INFO::Testing a comparison of protein: 1/Rv0711(484 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0712(485 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0714(486 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0715(487 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0716(488 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0717(489 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0718(490 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0719(491 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0720(492 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0721(493 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0722(494 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0723(495 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0724(496 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0726c(497 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0729(498 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0730(499 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0731c(500 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0732(501 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0733(502 of 2614)
## 
  |                                                                       
  |=============                                                    |  19%2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0734(503 of 2614)
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0736(504 of 2614)
## 2018-05-16 17:57:57 INFO::Fitting a single group.
## 2018-05-16 17:57:57 WARNING::Results of protein 1/Rv0736 for comparison cf
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0737(505 of 2614)
## 2018-05-16 17:57:57 INFO::Fitting a single group.
## 2018-05-16 17:57:57 WARNING::Results of protein 1/Rv0737 for comparison cf
## 2018-05-16 17:57:57 INFO::Testing a comparison of protein: 1/Rv0738(506 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0740(507 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0743c(508 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0744c(509 of 2614)
## 2018-05-16 17:57:58 INFO::Fitting a single group.
## 2018-05-16 17:57:58 WARNING::Results of protein 1/Rv0744c for comparison cf
## 
  |                                                                       
  |=============                                                    |  20%2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0748(510 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0751c(511 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0752c(512 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0753c(513 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0757(514 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0758(515 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0759c(516 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0760c(517 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0761c(518 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0763c(519 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0764c(520 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0765c(521 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0766c(522 of 2614)
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0767c(523 of 2614)
## 2018-05-16 17:57:58 INFO::Fitting a single group.
## 2018-05-16 17:57:58 WARNING::Results of protein 1/Rv0767c for comparison cf
## 2018-05-16 17:57:58 INFO::Testing a comparison of protein: 1/Rv0768(524 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0769(525 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0770(526 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0772(527 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0773c(528 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0774c(529 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0777(530 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0778(531 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0780(532 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0785(533 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0786c(534 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0787A(535 of 2614)
## 
  |                                                                       
  |=============                                                    |  21%2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0788(536 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0790c(537 of 2614)
## 2018-05-16 17:57:59 INFO::Fitting a single group.
## 2018-05-16 17:57:59 WARNING::Results of protein 1/Rv0790c for comparison cf
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0791c(538 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0794c(539 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0798c(540 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0799c(541 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0800(542 of 2614)
## 
  |                                                                       
  |==============                                                   |  21%2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0801(543 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0802c(544 of 2614)
## 2018-05-16 17:57:59 INFO::Testing a comparison of protein: 1/Rv0803(545 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0805(546 of 2614)
## 2018-05-16 17:58:00 INFO::Fitting a single group.
## 2018-05-16 17:58:00 WARNING::Results of protein 1/Rv0805 for comparison cf
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0806c(547 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0807(548 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0808(549 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0809(550 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0810c(551 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0811c(552 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0812(553 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0813c(554 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0817c(555 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0818(556 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0819(557 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0820(558 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0821c(559 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0822c(560 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0823c(561 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0824c(562 of 2614)
## 
  |                                                                       
  |==============                                                   |  22%2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0825c(563 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0827c(564 of 2614)
## 2018-05-16 17:58:00 INFO::Fitting a single group.
## 2018-05-16 17:58:00 WARNING::Results of protein 1/Rv0827c for comparison cf
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0830(565 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0831c(566 of 2614)
## 2018-05-16 17:58:00 INFO::Testing a comparison of protein: 1/Rv0835(567 of 2614)
## 2018-05-16 17:58:00 INFO::Fitting a single group.
## 2018-05-16 17:58:00 WARNING::Results of protein 1/Rv0835 for comparison cf
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0838(568 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0840c(569 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0844c(570 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0845(571 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0846c(572 of 2614)
## 2018-05-16 17:58:01 WARNING::Results of protein 1/Rv0846c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0852(573 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0853c(574 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0854(575 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0855(576 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0857(577 of 2614)
## 2018-05-16 17:58:01 INFO::Fitting a single group.
## 2018-05-16 17:58:01 WARNING::Results of protein 1/Rv0857 for comparison cf
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0858c(578 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0859(579 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0860(580 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0861c(581 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0862c(582 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0863(583 of 2614)
## 
  |                                                                       
  |===============                                                  |  22%2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0864(584 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0865(585 of 2614)
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0868c(586 of 2614)
## 2018-05-16 17:58:01 INFO::Fitting a single group.
## 2018-05-16 17:58:01 WARNING::Results of protein 1/Rv0868c for comparison cf
## 2018-05-16 17:58:01 INFO::Testing a comparison of protein: 1/Rv0871(587 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0873(588 of 2614)
## 
  |                                                                       
  |===============                                                  |  23%2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0875c(589 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0876c(590 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0877(591 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0880(592 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0883c(593 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0884c(594 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0886(595 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0887c(596 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0888(597 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0889c(598 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0890c(599 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0892(600 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0893c(601 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0896(602 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0897c(603 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0898c(604 of 2614)
## 2018-05-16 17:58:02 INFO::Testing a comparison of protein: 1/Rv0899(605 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0901(606 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0902c(607 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0903c(608 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0904c(609 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0905(610 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0906(611 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0907(612 of 2614)
## 2018-05-16 17:58:03 WARNING::Results of protein 1/Rv0907 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0908(613 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0909(614 of 2614)
## 
  |                                                                       
  |===============                                                  |  24%2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0910(615 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0911(616 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0913c(617 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0914c(618 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0923c(619 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0925c(620 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0926c(621 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0927c(622 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0928(623 of 2614)
## 
  |                                                                       
  |================                                                 |  24%2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0931c(624 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0932c(625 of 2614)
## 2018-05-16 17:58:03 INFO::Testing a comparison of protein: 1/Rv0933(626 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0934(627 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0936(628 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0937c(629 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0938(630 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0939(631 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0940c(632 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0941c(633 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0946c(634 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0948c(635 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0949(636 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0951(637 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0952(638 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0953c(639 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0954(640 of 2614)
## 
  |                                                                       
  |================                                                 |  25%2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0956(641 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0957(642 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0958(643 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0959(644 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0959A(645 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0960(646 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0966c(647 of 2614)
## 2018-05-16 17:58:04 INFO::Testing a comparison of protein: 1/Rv0967(648 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0968(649 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0969(650 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0971c(651 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0972c(652 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0973c(653 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0974c(654 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0979A(655 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0981(656 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0982(657 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0983(658 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0984(659 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0985c(660 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0986(661 of 2614)
## 2018-05-16 17:58:05 INFO::Fitting a single group.
## 2018-05-16 17:58:05 WARNING::Results of protein 1/Rv0986 for comparison cf
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0989c(662 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0991c(663 of 2614)
## 
  |                                                                       
  |=================                                                |  25%2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0992c(664 of 2614)
## 2018-05-16 17:58:05 INFO::Testing a comparison of protein: 1/Rv0993(665 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv0994(666 of 2614)
## 
  |                                                                       
  |=================                                                |  26%2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv0997a(667 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv0998(668 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv0999(669 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1001(670 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1002c(671 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1003(672 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1005c(673 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1006(674 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1007c(675 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1008(676 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1009(677 of 2614)
## 2018-05-16 17:58:06 WARNING::Results of protein 1/Rv1009 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1010(678 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1011(679 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1013(680 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1015c(681 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1016c(682 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1017c(683 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1018c(684 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1019(685 of 2614)
## 2018-05-16 17:58:06 INFO::Testing a comparison of protein: 1/Rv1020(686 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1021(687 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1022(688 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1023(689 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1024(690 of 2614)
## 2018-05-16 17:58:07 WARNING::Results of protein 1/Rv1024 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1025(691 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1026(692 of 2614)
## 2018-05-16 17:58:07 INFO::Fitting a single group.
## 2018-05-16 17:58:07 WARNING::Results of protein 1/Rv1026 for comparison cf
## 
  |                                                                       
  |=================                                                |  27%2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1028c(693 of 2614)
## 2018-05-16 17:58:07 INFO::Fitting a single group.
## 2018-05-16 17:58:07 WARNING::Results of protein 1/Rv1028c for comparison cf
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1030(694 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1032c(695 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1033c(696 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1043c(697 of 2614)
## 2018-05-16 17:58:07 INFO::Fitting a single group.
## 2018-05-16 17:58:07 WARNING::Results of protein 1/Rv1043c for comparison cf
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1045(698 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1048c(699 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1050(700 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1056(701 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1058(702 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1059(703 of 2614)
## 
  |                                                                       
  |==================                                               |  27%2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1060(704 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1061(705 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1062(706 of 2614)
## 2018-05-16 17:58:07 INFO::Testing a comparison of protein: 1/Rv1063c(707 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1069c(708 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1070c(709 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1071c(710 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1072(711 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1074c(712 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1077(713 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1078(714 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1079(715 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1080c(716 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1082(717 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1083(718 of 2614)
## 2018-05-16 17:58:08 INFO::Fitting a single group.
## 2018-05-16 17:58:08 WARNING::Results of protein 1/Rv1083 for comparison cf
## 
  |                                                                       
  |==================                                               |  28%2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1084(719 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1086(720 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1087(721 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1092c(722 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1093(723 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1094(724 of 2614)
## 2018-05-16 17:58:08 INFO::Testing a comparison of protein: 1/Rv1095(725 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1096(726 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1097c(727 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1098c(728 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1099c(729 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1100(730 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1101c(731 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1106c(732 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1107c(733 of 2614)
## 2018-05-16 17:58:09 INFO::Fitting a single group.
## 2018-05-16 17:58:09 WARNING::Results of protein 1/Rv1107c for comparison cf
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1108c(734 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1109c(735 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1110(736 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1111c(737 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1112(738 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1113(739 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1117(740 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1118c(741 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1121(742 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1122(743 of 2614)
## 
  |                                                                       
  |===================                                              |  28%2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1123c(744 of 2614)
## 
  |                                                                       
  |===================                                              |  29%2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1124(745 of 2614)
## 2018-05-16 17:58:09 INFO::Testing a comparison of protein: 1/Rv1125(746 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1126c(747 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1127c(748 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1130(749 of 2614)
## 2018-05-16 17:58:10 WARNING::Results of protein 1/Rv1130 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1132(750 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1133c(751 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1140(752 of 2614)
## 2018-05-16 17:58:10 INFO::Fitting a single group.
## 2018-05-16 17:58:10 WARNING::Results of protein 1/Rv1140 for comparison cf
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1141c(753 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1142c(754 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1143(755 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1144(756 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1147(757 of 2614)
## 2018-05-16 17:58:10 INFO::Fitting a single group.
## 2018-05-16 17:58:10 WARNING::Results of protein 1/Rv1147 for comparison cf
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1151c(758 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1152(759 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1154c(760 of 2614)
## 2018-05-16 17:58:10 INFO::Fitting a single group.
## 2018-05-16 17:58:10 WARNING::Results of protein 1/Rv1154c for comparison cf
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1155(761 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1155a(762 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1156(763 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1157c(764 of 2614)
## 2018-05-16 17:58:10 WARNING::Results of protein 1/Rv1157c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1159A(765 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1160(766 of 2614)
## 2018-05-16 17:58:10 INFO::Testing a comparison of protein: 1/Rv1161(767 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1162(768 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1164(769 of 2614)
## 2018-05-16 17:58:11 INFO::Fitting a single group.
## 2018-05-16 17:58:11 WARNING::Results of protein 1/Rv1164 for comparison cf
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1165(770 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1166(771 of 2614)
## 
  |                                                                       
  |===================                                              |  30%2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1167c(772 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1170(773 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1172c(774 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1173(775 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1174c(776 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1175c(777 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1176c(778 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1177(779 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1178(780 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1179c(781 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1180(782 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1181(783 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1182(784 of 2614)
## 
  |                                                                       
  |====================                                             |  30%2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1183(785 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1184c(786 of 2614)
## 2018-05-16 17:58:11 WARNING::Results of protein 1/Rv1184c for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1185c(787 of 2614)
## 2018-05-16 17:58:11 INFO::Testing a comparison of protein: 1/Rv1187(788 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1188(789 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1191(790 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1192(791 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1193(792 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1194c(793 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1196(794 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1198(795 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1201c(796 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1202(797 of 2614)
## 
  |                                                                       
  |====================                                             |  31%2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1204c(798 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1206(799 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1207(800 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1208(801 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1209(802 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1210(803 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1211(804 of 2614)
## 2018-05-16 17:58:12 INFO::Testing a comparison of protein: 1/Rv1212c(805 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1213(806 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1215c(807 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1218c(808 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1220c(809 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1223(810 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1224(811 of 2614)
## 2018-05-16 17:58:13 INFO::Fitting a single group.
## 2018-05-16 17:58:13 WARNING::Results of protein 1/Rv1224 for comparison cf
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1226c(812 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1227c(813 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1229c(814 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1231c(815 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1232c(816 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1234(817 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1235(818 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1237(819 of 2614)
## 2018-05-16 17:58:13 INFO::Fitting a single group.
## 2018-05-16 17:58:13 WARNING::Results of protein 1/Rv1237 for comparison cf
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1238(820 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1239c(821 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1240(822 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1241(823 of 2614)
## 
  |                                                                       
  |====================                                             |  32%2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1244(824 of 2614)
## 
  |                                                                       
  |=====================                                            |  32%2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1245c(825 of 2614)
## 2018-05-16 17:58:13 INFO::Testing a comparison of protein: 1/Rv1246c(826 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1247c(827 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1248c(828 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1249c(829 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1251c(830 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1253(831 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1255c(832 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1256c(833 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1257c(834 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1259(835 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1260(836 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1261c(837 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1263(838 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1264(839 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1265(840 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1266c(841 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1267c(842 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1269c(843 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1270c(844 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1273c(845 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1274(846 of 2614)
## 2018-05-16 17:58:14 INFO::Testing a comparison of protein: 1/Rv1275(847 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1276c(848 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1277(849 of 2614)
## 
  |                                                                       
  |=====================                                            |  33%2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1278(850 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1279(851 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1280c(852 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1281c(853 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1283c(854 of 2614)
## 2018-05-16 17:58:15 INFO::Fitting a single group.
## 2018-05-16 17:58:15 WARNING::Results of protein 1/Rv1283c for comparison cf
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1284(855 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1285(856 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1286(857 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1287(858 of 2614)
## 2018-05-16 17:58:15 INFO::Fitting a single group.
## 2018-05-16 17:58:15 WARNING::Results of protein 1/Rv1287 for comparison cf
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1288(859 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1289(860 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1290c(861 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1292(862 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1293(863 of 2614)
## 2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1294(864 of 2614)
## 
  |                                                                       
  |======================                                           |  33%2018-05-16 17:58:15 INFO::Testing a comparison of protein: 1/Rv1295(865 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1296(866 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1297(867 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1298(868 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1299(869 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1301(870 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1302(871 of 2614)
## 2018-05-16 17:58:16 INFO::Fitting a single group.
## 2018-05-16 17:58:16 WARNING::Results of protein 1/Rv1302 for comparison cf
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1304(872 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1306(873 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1307(874 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1308(875 of 2614)
## 
  |                                                                       
  |======================                                           |  34%2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1309(876 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1310(877 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1311(878 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1312(879 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1314c(880 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1315(881 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1316c(882 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1317c(883 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1318c(884 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1320c(885 of 2614)
## 2018-05-16 17:58:16 INFO::Fitting a single group.
## 2018-05-16 17:58:16 WARNING::Results of protein 1/Rv1320c for comparison cf
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1321(886 of 2614)
## 2018-05-16 17:58:16 INFO::Testing a comparison of protein: 1/Rv1322(887 of 2614)
## 2018-05-16 17:58:16 INFO::Fitting a single group.
## 2018-05-16 17:58:16 WARNING::Results of protein 1/Rv1322 for comparison cf
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1322A(888 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1323(889 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1324(890 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1325c(891 of 2614)
## 2018-05-16 17:58:17 INFO::Fitting a single group.
## 2018-05-16 17:58:17 WARNING::Results of protein 1/Rv1325c for comparison cf
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1326c(892 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1327c(893 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1328(894 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1329c(895 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1330c(896 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1331(897 of 2614)
## 2018-05-16 17:58:17 INFO::Fitting a single group.
## 2018-05-16 17:58:17 WARNING::Results of protein 1/Rv1331 for comparison cf
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1332(898 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1333(899 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1334(900 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1335(901 of 2614)
## 
  |                                                                       
  |======================                                           |  35%2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1336(902 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1338(903 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1339(904 of 2614)
## 
  |                                                                       
  |=======================                                          |  35%2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1340(905 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1341(906 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1345(907 of 2614)
## 2018-05-16 17:58:17 INFO::Testing a comparison of protein: 1/Rv1346(908 of 2614)
## 2018-05-16 17:58:17 INFO::Fitting a single group.
## 2018-05-16 17:58:17 WARNING::Results of protein 1/Rv1346 for comparison cf
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1347c(909 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1348(910 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1349(911 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1350(912 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1352(913 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1360(914 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1362c(915 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1363c(916 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1364c(917 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1366(918 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1367c(919 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1368(920 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1377c(921 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1379(922 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1380(923 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1381(924 of 2614)
## 2018-05-16 17:58:18 INFO::Testing a comparison of protein: 1/Rv1382(925 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1383(926 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1384(927 of 2614)
## 
  |                                                                       
  |=======================                                          |  36%2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1385(928 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1386(929 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1387(930 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1388(931 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1389(932 of 2614)
## 2018-05-16 17:58:19 WARNING::Results of protein 1/Rv1389 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1390(933 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1391(934 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1392(935 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1398c(936 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1399c(937 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1400c(938 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1402(939 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1404(940 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1406(941 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1407(942 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1408(943 of 2614)
## 2018-05-16 17:58:19 INFO::Fitting a single group.
## 2018-05-16 17:58:19 WARNING::Results of protein 1/Rv1408 for comparison cf
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1409(944 of 2614)
## 2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1411c(945 of 2614)
## 
  |                                                                       
  |========================                                         |  36%2018-05-16 17:58:19 INFO::Testing a comparison of protein: 1/Rv1412(946 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1415(947 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1416(948 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1418(949 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1419(950 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1420(951 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1421(952 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1422(953 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1423(954 of 2614)
## 
  |                                                                       
  |========================                                         |  37%2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1424c(955 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1425(956 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1426c(957 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1427c(958 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1428c(959 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1429(960 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1433(961 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1435c(962 of 2614)
## 2018-05-16 17:58:20 WARNING::Results of protein 1/Rv1435c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1436(963 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1437(964 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1438(965 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1439c(966 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1442(967 of 2614)
## 2018-05-16 17:58:20 INFO::Testing a comparison of protein: 1/Rv1443c(968 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1444c(969 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1445c(970 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1446c(971 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1447c(972 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1448c(973 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1449c(974 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1454c(975 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1455(976 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1456c(977 of 2614)
## 2018-05-16 17:58:21 INFO::Fitting a single group.
## 2018-05-16 17:58:21 WARNING::Results of protein 1/Rv1456c for comparison cf
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1458c(978 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1461(979 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1462(980 of 2614)
## 
  |                                                                       
  |========================                                         |  38%2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1463(981 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1464(982 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1465(983 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1466(984 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1467c(985 of 2614)
## 
  |                                                                       
  |=========================                                        |  38%2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1471(986 of 2614)
## 2018-05-16 17:58:21 INFO::Testing a comparison of protein: 1/Rv1472(987 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1473(988 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1473A(989 of 2614)
## 2018-05-16 17:58:22 INFO::Fitting a single group.
## 2018-05-16 17:58:22 WARNING::Results of protein 1/Rv1473A for comparison cf
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1474c(990 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1475c(991 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1476(992 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1477(993 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1478(994 of 2614)
## 2018-05-16 17:58:22 WARNING::Results of protein 1/Rv1478 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1479(995 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1480(996 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1481(997 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1483(998 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1484(999 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1486c(1000 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1487(1001 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1488(1002 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1489(1003 of 2614)
## 2018-05-16 17:58:22 INFO::Fitting a single group.
## 2018-05-16 17:58:22 WARNING::Results of protein 1/Rv1489 for comparison cf
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1492(1004 of 2614)
## 2018-05-16 17:58:22 INFO::Testing a comparison of protein: 1/Rv1493(1005 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1494(1006 of 2614)
## 
  |                                                                       
  |=========================                                        |  39%2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1496(1007 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1497(1008 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1498A(1009 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1498c(1010 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1500(1011 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1501(1012 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1502(1013 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1507c(1014 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1508c(1015 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1511(1016 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1512(1017 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1513(1018 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1514c(1019 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1515c(1020 of 2614)
## 2018-05-16 17:58:23 INFO::Fitting a single group.
## 2018-05-16 17:58:23 WARNING::Results of protein 1/Rv1515c for comparison cf
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1516c(1021 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1521(1022 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1523(1023 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1524(1024 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1527c(1025 of 2614)
## 
  |                                                                       
  |==========================                                       |  39%2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1529(1026 of 2614)
## 2018-05-16 17:58:23 INFO::Testing a comparison of protein: 1/Rv1530(1027 of 2614)
## 2018-05-16 17:58:23 INFO::Fitting a single group.
## 2018-05-16 17:58:23 WARNING::Results of protein 1/Rv1530 for comparison cf
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1531(1028 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1532c(1029 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1533(1030 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1534(1031 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1535(1032 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 
  |                                                                       
  |==========================                                       |  40%2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1536(1033 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1538c(1034 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1540(1035 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1543(1036 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1544(1037 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1546(1038 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1547(1039 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1556(1040 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1558(1041 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1559(1042 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1561(1043 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1562c(1044 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1563c(1045 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1564c(1046 of 2614)
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1565c(1047 of 2614)
## 2018-05-16 17:58:24 INFO::Fitting a single group.
## 2018-05-16 17:58:24 WARNING::Results of protein 1/Rv1565c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:24 INFO::Testing a comparison of protein: 1/Rv1566c(1048 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1569(1049 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1570(1050 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1571(1051 of 2614)
## 2018-05-16 17:58:25 WARNING::Results of protein 1/Rv1571 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1576c(1052 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1578c(1053 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1586c(1054 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1589(1055 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1590(1056 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1591(1057 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1592c(1058 of 2614)
## 
  |                                                                       
  |==========================                                       |  41%2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1593c(1059 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1594(1060 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1595(1061 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1596(1062 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1597(1063 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1598c(1064 of 2614)
## 2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1599(1065 of 2614)
## 
  |                                                                       
  |===========================                                      |  41%2018-05-16 17:58:25 INFO::Testing a comparison of protein: 1/Rv1600(1066 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1601(1067 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1602(1068 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1603(1069 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1605(1070 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1606(1071 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1608c(1072 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1609(1073 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1610(1074 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1611(1075 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1612(1076 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1613(1077 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1614(1078 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1615(1079 of 2614)
## 2018-05-16 17:58:26 INFO::Fitting a single group.
## 2018-05-16 17:58:26 WARNING::Results of protein 1/Rv1615 for comparison cf
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1617(1080 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1618(1081 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1620c(1082 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1621c(1083 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1622c(1084 of 2614)
## 
  |                                                                       
  |===========================                                      |  42%2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1623c(1085 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1625c(1086 of 2614)
## 2018-05-16 17:58:26 INFO::Testing a comparison of protein: 1/Rv1626(1087 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1627c(1088 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1628c(1089 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1629(1090 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1630(1091 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1631(1092 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1632c(1093 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1633(1094 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1636(1095 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1637c(1096 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1638(1097 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1638A(1098 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1640c(1099 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1641(1100 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1642(1101 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1643(1102 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1647(1103 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1649(1104 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1650(1105 of 2614)
## 
  |                                                                       
  |============================                                     |  42%2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1652(1106 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1653(1107 of 2614)
## 2018-05-16 17:58:27 INFO::Testing a comparison of protein: 1/Rv1654(1108 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1655(1109 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1656(1110 of 2614)
## 
  |                                                                       
  |============================                                     |  43%2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1657(1111 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1658(1112 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1659(1113 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1660(1114 of 2614)
## 2018-05-16 17:58:28 INFO::Fitting a single group.
## 2018-05-16 17:58:28 WARNING::Results of protein 1/Rv1660 for comparison cf
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1661(1115 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1663(1116 of 2614)
## 2018-05-16 17:58:28 INFO::Fitting a single group.
## 2018-05-16 17:58:28 WARNING::Results of protein 1/Rv1663 for comparison cf
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1664(1117 of 2614)
## 2018-05-16 17:58:28 INFO::Fitting a single group.
## 2018-05-16 17:58:28 WARNING::Results of protein 1/Rv1664 for comparison cf
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1665(1118 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1666c(1119 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1676(1120 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1677(1121 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1679(1122 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1680(1123 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1681(1124 of 2614)
## 2018-05-16 17:58:28 INFO::Testing a comparison of protein: 1/Rv1683(1125 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1684(1126 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1685c(1127 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1686c(1128 of 2614)
## 2018-05-16 17:58:29 INFO::Fitting a single group.
## 2018-05-16 17:58:29 WARNING::Results of protein 1/Rv1686c for comparison cf
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1687c(1129 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1688(1130 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1689(1131 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1691(1132 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1692(1133 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1695(1134 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1696(1135 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1697(1136 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1698(1137 of 2614)
## 
  |                                                                       
  |============================                                     |  44%2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1699(1138 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1700(1139 of 2614)
## 2018-05-16 17:58:29 WARNING::Results of protein 1/Rv1700 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1701(1140 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1703c(1141 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1704c(1142 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1707(1143 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1708(1144 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1710(1145 of 2614)
## 2018-05-16 17:58:29 INFO::Testing a comparison of protein: 1/Rv1711(1146 of 2614)
## 
  |                                                                       
  |=============================                                    |  44%2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1712(1147 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1713(1148 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1719(1149 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1721c(1150 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1722(1151 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1727(1152 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1729c(1153 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1730c(1154 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1731(1155 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1732c(1156 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1738(1157 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1742(1158 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1743(1159 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1745c(1160 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1746(1161 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1747(1162 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1748(1163 of 2614)
## 
  |                                                                       
  |=============================                                    |  45%2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1749c(1164 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1750c(1165 of 2614)
## 2018-05-16 17:58:30 INFO::Testing a comparison of protein: 1/Rv1751(1166 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1754c(1167 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1762c(1168 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1767(1169 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1769(1170 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1770(1171 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1771(1172 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1773c(1173 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1774(1174 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1778c(1175 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1779c(1176 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1780(1177 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1781c(1178 of 2614)
## 2018-05-16 17:58:31 INFO::Fitting a single group.
## 2018-05-16 17:58:31 WARNING::Results of protein 1/Rv1781c for comparison cf
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1782(1179 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1783(1180 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1785c(1181 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1789(1182 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1793(1183 of 2614)
## 2018-05-16 17:58:31 INFO::Testing a comparison of protein: 1/Rv1794(1184 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1795(1185 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1796(1186 of 2614)
## 
  |                                                                       
  |==============================                                   |  45%2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1797(1187 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1798(1188 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1808(1189 of 2614)
## 
  |                                                                       
  |==============================                                   |  46%2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1809(1190 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1810(1191 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1812c(1192 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1815(1193 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1816(1194 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1817(1195 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1819c(1196 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1820(1197 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1821(1198 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1822(1199 of 2614)
## 2018-05-16 17:58:32 INFO::Fitting a single group.
## 2018-05-16 17:58:32 WARNING::Results of protein 1/Rv1822 for comparison cf
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1823(1200 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1825(1201 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1826(1202 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1827(1203 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1828(1204 of 2614)
## 2018-05-16 17:58:32 INFO::Testing a comparison of protein: 1/Rv1829(1205 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1830(1206 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1832(1207 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1833c(1208 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1835c(1209 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1836c(1210 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1837c(1211 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1838c(1212 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1839c(1213 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1842c(1214 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1843c(1215 of 2614)
## 
  |                                                                       
  |==============================                                   |  47%2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1847(1216 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1848(1217 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1850(1218 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1852(1219 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1853(1220 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1854c(1221 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1855c(1222 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1856c(1223 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1860(1224 of 2614)
## 2018-05-16 17:58:33 INFO::Testing a comparison of protein: 1/Rv1862(1225 of 2614)
## 2018-05-16 17:58:33 INFO::Fitting a single group.
## 2018-05-16 17:58:33 WARNING::Results of protein 1/Rv1862 for comparison cf
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1864c(1226 of 2614)
## 
  |                                                                       
  |===============================                                  |  47%2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1865c(1227 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1866(1228 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1867(1229 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1868(1230 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1869c(1231 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1871c(1232 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1872c(1233 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1874(1234 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1875(1235 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1876(1236 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1878(1237 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1880c(1238 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1881c(1239 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1882c(1240 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1885c(1241 of 2614)
## 
  |                                                                       
  |===============================                                  |  48%2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1886c(1242 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1887(1243 of 2614)
## 2018-05-16 17:58:34 WARNING::Results of protein 1/Rv1887 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1891(1244 of 2614)
## 2018-05-16 17:58:34 WARNING::Results of protein 1/Rv1891 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1893(1245 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1894c(1246 of 2614)
## 2018-05-16 17:58:34 INFO::Testing a comparison of protein: 1/Rv1896c(1247 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1899c(1248 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1900c(1249 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1901(1250 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1904(1251 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1905c(1252 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1906c(1253 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1908c(1254 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1909c(1255 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1910c(1256 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1912c(1257 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1913(1258 of 2614)
## 2018-05-16 17:58:35 INFO::Fitting a single group.
## 2018-05-16 17:58:35 WARNING::Results of protein 1/Rv1913 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1915(1259 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1919c(1260 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1920(1261 of 2614)
## 2018-05-16 17:58:35 INFO::Testing a comparison of protein: 1/Rv1922(1262 of 2614)
## 2018-05-16 17:58:35 INFO::Fitting a single group.
## 2018-05-16 17:58:35 WARNING::Results of protein 1/Rv1922 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1923(1263 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1924c(1264 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1925(1265 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1926c(1266 of 2614)
## 
  |                                                                       
  |================================                                 |  48%2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1927(1267 of 2614)
## 
  |                                                                       
  |================================                                 |  49%2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1928c(1268 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1929c(1269 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1932(1270 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1936(1271 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1938(1272 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1942c(1273 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1943c(1274 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1944c(1275 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1956(1276 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1957(1277 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1960c(1278 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1962A(1279 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1962c(1280 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1963c(1281 of 2614)
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1975(1282 of 2614)
## 2018-05-16 17:58:36 WARNING::Results of protein 1/Rv1975 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:36 INFO::Testing a comparison of protein: 1/Rv1976c(1283 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1977(1284 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1978(1285 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1980c(1286 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1981c(1287 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1982A(1288 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1983(1289 of 2614)
## 2018-05-16 17:58:37 WARNING::Results of protein 1/Rv1983 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1984c(1290 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1987(1291 of 2614)
## 2018-05-16 17:58:37 WARNING::Results of protein 1/Rv1987 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1989c(1292 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1990c(1293 of 2614)
## 
  |                                                                       
  |================================                                 |  50%2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1991A(1294 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1991c(1295 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:37 WARNING::Results of protein 1/Rv1991c for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1992c(1296 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1993c(1297 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv1996(1298 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv2000(1299 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv2001(1300 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv2002(1301 of 2614)
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv2004c(1302 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:37 INFO::Testing a comparison of protein: 1/Rv2005c(1303 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2006(1304 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2007c(1305 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2008c(1306 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2010(1307 of 2614)
## 
  |                                                                       
  |=================================                                |  50%2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2012(1308 of 2614)
## 2018-05-16 17:58:38 INFO::Fitting a single group.
## 2018-05-16 17:58:38 WARNING::Results of protein 1/Rv2012 for comparison cf
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2018(1309 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2019(1310 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2021c(1311 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2026c(1312 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2027c(1313 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2031c(1314 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2035(1315 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2037c(1316 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2038c(1317 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2041c(1318 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2042c(1319 of 2614)
## 2018-05-16 17:58:38 INFO::Testing a comparison of protein: 1/Rv2045c(1320 of 2614)
## 
  |                                                                       
  |=================================                                |  51%2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2047c(1321 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2048c(1322 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2050(1323 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2051c(1324 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2052c(1325 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2054(1326 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2055c(1327 of 2614)
## 2018-05-16 17:58:39 INFO::Fitting a single group.
## 2018-05-16 17:58:39 WARNING::Results of protein 1/Rv2055c for comparison cf
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2061c(1328 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2062c(1329 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2063A(1330 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2064(1331 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2065(1332 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2066(1333 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2067c(1334 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2068c(1335 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2070c(1336 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2071c(1337 of 2614)
## 2018-05-16 17:58:39 WARNING::Results of protein 1/Rv2071c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2073c(1338 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2074(1339 of 2614)
## 2018-05-16 17:58:39 INFO::Testing a comparison of protein: 1/Rv2080(1340 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2082(1341 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2083(1342 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2089c(1343 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2090(1344 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2091c(1345 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2092c(1346 of 2614)
## 
  |                                                                       
  |=================================                                |  52%2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2094c(1347 of 2614)
## 
  |                                                                       
  |==================================                               |  52%2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2095c(1348 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2096c(1349 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2097c(1350 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2101(1351 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2102(1352 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2103c(1353 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2104c(1354 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2109c(1355 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2110c(1356 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2111c(1357 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2112c(1358 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2113(1359 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2114(1360 of 2614)
## 2018-05-16 17:58:40 INFO::Testing a comparison of protein: 1/Rv2115c(1361 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2116(1362 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2117(1363 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:41 WARNING::Results of protein 1/Rv2117 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2118c(1364 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2121c(1365 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2122c(1366 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2124c(1367 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2125(1368 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2129c(1369 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2130c(1370 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2131c(1371 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2132(1372 of 2614)
## 
  |                                                                       
  |==================================                               |  53%2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2134c(1373 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2135c(1374 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2137c(1375 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2138(1376 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2139(1377 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2140c(1378 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2141c(1379 of 2614)
## 2018-05-16 17:58:41 INFO::Testing a comparison of protein: 1/Rv2142c(1380 of 2614)
## 2018-05-16 17:58:41 INFO::Fitting a single group.
## 2018-05-16 17:58:41 WARNING::Results of protein 1/Rv2142c for comparison cf
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2145c(1381 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2147c(1382 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2148c(1383 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2149c(1384 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2150c(1385 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2151c(1386 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2152c(1387 of 2614)
## 
  |                                                                       
  |===================================                              |  53%2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2153c(1388 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2155c(1389 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2157c(1390 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2158c(1391 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2159c(1392 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2161c(1393 of 2614)
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2162c(1394 of 2614)
## 2018-05-16 17:58:42 WARNING::Results of protein 1/Rv2162c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2163c(1395 of 2614)
## 2018-05-16 17:58:42 WARNING::Results of protein 1/Rv2163c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2164c(1396 of 2614)
## 2018-05-16 17:58:42 WARNING::Results of protein 1/Rv2164c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:42 INFO::Testing a comparison of protein: 1/Rv2165c(1397 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2166c(1398 of 2614)
## 
  |                                                                       
  |===================================                              |  54%2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2169c(1399 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2170(1400 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2171(1401 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2172c(1402 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2173(1403 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2174(1404 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2175c(1405 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2176(1406 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2178c(1407 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2179c(1408 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2182c(1409 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2183c(1410 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2184c(1411 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2185c(1412 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2187(1413 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2188c(1414 of 2614)
## 2018-05-16 17:58:43 INFO::Testing a comparison of protein: 1/Rv2190c(1415 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2192c(1416 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2194(1417 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2195(1418 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2196(1419 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2198c(1420 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2200c(1421 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2201(1422 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2202c(1423 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2203(1424 of 2614)
## 
  |                                                                       
  |===================================                              |  55%2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2204c(1425 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2206(1426 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2207(1427 of 2614)
## 
  |                                                                       
  |====================================                             |  55%2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2210c(1428 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2211c(1429 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2212(1430 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2213(1431 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2214c(1432 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2215(1433 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2216(1434 of 2614)
## 2018-05-16 17:58:44 INFO::Testing a comparison of protein: 1/Rv2217(1435 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2218(1436 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2219(1437 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2220(1438 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2221c(1439 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2222c(1440 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2223c(1441 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2224c(1442 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2226(1443 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2228c(1444 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2229c(1445 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2230c(1446 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2231c(1447 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2232(1448 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2235(1449 of 2614)
## 2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2237(1450 of 2614)
## 
  |                                                                       
  |====================================                             |  56%2018-05-16 17:58:45 INFO::Testing a comparison of protein: 1/Rv2237A(1451 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2238c(1452 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2240c(1453 of 2614)
## 2018-05-16 17:58:46 WARNING::Results of protein 1/Rv2240c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2241(1454 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2242(1455 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2243(1456 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2244(1457 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2245(1458 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2246(1459 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2247(1460 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2249c(1461 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2251(1462 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2252(1463 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2253(1464 of 2614)
## 2018-05-16 17:58:46 WARNING::Results of protein 1/Rv2253 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2256c(1465 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2257c(1466 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2258c(1467 of 2614)
## 
  |                                                                       
  |=====================================                            |  56%2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2259(1468 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2260(1469 of 2614)
## 2018-05-16 17:58:46 INFO::Testing a comparison of protein: 1/Rv2263(1470 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2264c(1471 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2271(1472 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2276(1473 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2280(1474 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2282c(1475 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2284(1476 of 2614)
## 
  |                                                                       
  |=====================================                            |  57%2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2285(1477 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2287(1478 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2289(1479 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2290(1480 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2291(1481 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2294(1482 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2295(1483 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2296(1484 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2297(1485 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2298(1486 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2299c(1487 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2300c(1488 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2301(1489 of 2614)
## 2018-05-16 17:58:47 INFO::Testing a comparison of protein: 1/Rv2302(1490 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2303c(1491 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2305(1492 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2307c(1493 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2313c(1494 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2314c(1495 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2315c(1496 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2325c(1497 of 2614)
## 2018-05-16 17:58:48 INFO::Fitting a single group.
## 2018-05-16 17:58:48 WARNING::Results of protein 1/Rv2325c for comparison cf
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2326c(1498 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2327(1499 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2332(1500 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2334(1501 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2336(1502 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2337c(1503 of 2614)
## 
  |                                                                       
  |=====================================                            |  58%2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2338c(1504 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2339(1505 of 2614)
## 2018-05-16 17:58:48 INFO::Fitting a single group.
## 2018-05-16 17:58:48 WARNING::Results of protein 1/Rv2339 for comparison cf
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2342(1506 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2343c(1507 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2344c(1508 of 2614)
## 
  |                                                                       
  |======================================                           |  58%2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2345(1509 of 2614)
## 2018-05-16 17:58:48 INFO::Testing a comparison of protein: 1/Rv2346c(1510 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2349c(1511 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:49 WARNING::Results of protein 1/Rv2349c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2350c(1512 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2351c(1513 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2352c(1514 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2357c(1515 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2358(1516 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2359(1517 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2360c(1518 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2361c(1519 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2363(1520 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2365c(1521 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2366c(1522 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2368c(1523 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2373c(1524 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2374c(1525 of 2614)
## 2018-05-16 17:58:49 INFO::Testing a comparison of protein: 1/Rv2375(1526 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2376c(1527 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2377c(1528 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2378c(1529 of 2614)
## 
  |                                                                       
  |======================================                           |  59%2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2379c(1530 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2380c(1531 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2382c(1532 of 2614)
## 2018-05-16 17:58:50 INFO::Fitting a single group.
## 2018-05-16 17:58:50 WARNING::Results of protein 1/Rv2382c for comparison cf
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2383c(1533 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2386c(1534 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2391(1535 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2392(1536 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2394(1537 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2397c(1538 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2400c(1539 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2402(1540 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2403c(1541 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2404c(1542 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2405(1543 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2406c(1544 of 2614)
## 2018-05-16 17:58:50 INFO::Testing a comparison of protein: 1/Rv2409c(1545 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2410c(1546 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2411c(1547 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2412(1548 of 2614)
## 
  |                                                                       
  |=======================================                          |  59%2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2413c(1549 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2416c(1550 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2417c(1551 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2418c(1552 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2419c(1553 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2420c(1554 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2421c(1555 of 2614)
## 
  |                                                                       
  |=======================================                          |  60%2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2423(1556 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2425c(1557 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2426c(1558 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2427c(1559 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2428(1560 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2429(1561 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2430c(1562 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2431c(1563 of 2614)
## 2018-05-16 17:58:51 WARNING::Results of protein 1/Rv2431c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2436(1564 of 2614)
## 2018-05-16 17:58:51 INFO::Fitting a single group.
## 2018-05-16 17:58:51 WARNING::Results of protein 1/Rv2436 for comparison cf
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2438c(1565 of 2614)
## 2018-05-16 17:58:51 INFO::Testing a comparison of protein: 1/Rv2439c(1566 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2440c(1567 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2441c(1568 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2442c(1569 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2444c(1570 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2445c(1571 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2447c(1572 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2448c(1573 of 2614)
## 2018-05-16 17:58:52 INFO::Testing a comparison of protein: 1/Rv2449c(1574 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2453c(1575 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2454c(1576 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2455c(1577 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2457c(1578 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2458(1579 of 2614)
## 2018-05-16 17:58:55 INFO::Fitting a single group.
## 2018-05-16 17:58:55 WARNING::Results of protein 1/Rv2458 for comparison cf
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2460c(1580 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2461c(1581 of 2614)
## 
  |                                                                       
  |=======================================                          |  61%2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2462c(1582 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2463(1583 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2464c(1584 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2465c(1585 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2466c(1586 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2467(1587 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2468c(1588 of 2614)
## 
  |                                                                       
  |========================================                         |  61%2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2470(1589 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2471(1590 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2473(1591 of 2614)
## 2018-05-16 17:58:55 INFO::Testing a comparison of protein: 1/Rv2474c(1592 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2476c(1593 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2477c(1594 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2482c(1595 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2483c(1596 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2484c(1597 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2486(1598 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2488c(1599 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2493(1600 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2495c(1601 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2496c(1602 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2497c(1603 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2498c(1604 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2499c(1605 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2500c(1606 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2501c(1607 of 2614)
## 
  |                                                                       
  |========================================                         |  62%2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2502c(1608 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2503c(1609 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2504c(1610 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2509(1611 of 2614)
## 2018-05-16 17:58:56 INFO::Testing a comparison of protein: 1/Rv2510c(1612 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2511(1613 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2515c(1614 of 2614)
## 2018-05-16 17:58:57 INFO::Fitting a single group.
## 2018-05-16 17:58:57 WARNING::Results of protein 1/Rv2515c for comparison cf
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2516c(1615 of 2614)
## 2018-05-16 17:58:57 INFO::Fitting a single group.
## 2018-05-16 17:58:57 WARNING::Results of protein 1/Rv2516c for comparison cf
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2518c(1616 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2520c(1617 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2521(1618 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2522c(1619 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2524c(1620 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2525c(1621 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2526(1622 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2527(1623 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2528c(1624 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2529(1625 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2530A(1626 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2531c(1627 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2532c(1628 of 2614)
## 
  |                                                                       
  |=========================================                        |  62%2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2533c(1629 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2534c(1630 of 2614)
## 2018-05-16 17:58:57 INFO::Testing a comparison of protein: 1/Rv2535c(1631 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2536(1632 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2538c(1633 of 2614)
## 
  |                                                                       
  |=========================================                        |  63%2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2539c(1634 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2540c(1635 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2548A(1636 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2553c(1637 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2554c(1638 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2555c(1639 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2556c(1640 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2557(1641 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2558(1642 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2559c(1643 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2563(1644 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2564(1645 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2565(1646 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2566(1647 of 2614)
## 2018-05-16 17:58:58 INFO::Testing a comparison of protein: 1/Rv2567(1648 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2568c(1649 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2569c(1650 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2570(1651 of 2614)
## 2018-05-16 17:58:59 INFO::Fitting a single group.
## 2018-05-16 17:58:59 WARNING::Results of protein 1/Rv2570 for comparison cf
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2571c(1652 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2572c(1653 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2573(1654 of 2614)
## 2018-05-16 17:58:59 INFO::Fitting a single group.
## 2018-05-16 17:58:59 WARNING::Results of protein 1/Rv2573 for comparison cf
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2574(1655 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2575(1656 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2576c(1657 of 2614)
## 2018-05-16 17:58:59 WARNING::Results of protein 1/Rv2576c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2579(1658 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2580c(1659 of 2614)
## 
  |                                                                       
  |=========================================                        |  64%2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2581c(1660 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2582(1661 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2583c(1662 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2584c(1663 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2585c(1664 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2586c(1665 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2587c(1666 of 2614)
## 2018-05-16 17:58:59 INFO::Testing a comparison of protein: 1/Rv2588c(1667 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2589(1668 of 2614)
## 
  |                                                                       
  |==========================================                       |  64%2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2590(1669 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2592c(1670 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2593c(1671 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2595(1672 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2597(1673 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2598(1674 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2601A(1675 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2603c(1676 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2604c(1677 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2605c(1678 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2606c(1679 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2607(1680 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2609c(1681 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2610c(1682 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2611c(1683 of 2614)
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2612c(1684 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2613c(1685 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2614c(1686 of 2614)
## 
  |                                                                       
  |==========================================                       |  65%2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2616(1687 of 2614)
## 2018-05-16 17:59:00 INFO::Fitting a single group.
## 2018-05-16 17:59:00 WARNING::Results of protein 1/Rv2616 for comparison cf
## 2018-05-16 17:59:00 INFO::Testing a comparison of protein: 1/Rv2618(1688 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2619c(1689 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2622(1690 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2623(1691 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2624c(1692 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2626c(1693 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2629(1694 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2632c(1695 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2633c(1696 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2637(1697 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2641(1698 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2643(1699 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2650c(1700 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2658c(1701 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2664(1702 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2667(1703 of 2614)
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2668(1704 of 2614)
## 2018-05-16 17:59:01 WARNING::Results of protein 1/Rv2668 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:01 INFO::Testing a comparison of protein: 1/Rv2670c(1705 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2671(1706 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2672(1707 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2673(1708 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2674(1709 of 2614)
## 
  |                                                                       
  |===========================================                      |  65%2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2675c(1710 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2676c(1711 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2677c(1712 of 2614)
## 
  |                                                                       
  |===========================================                      |  66%2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2678c(1713 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2679(1714 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2680(1715 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2681(1716 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2682c(1717 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2683(1718 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2689c(1719 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2690c(1720 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2691(1721 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2692(1722 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2694c(1723 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2695(1724 of 2614)
## 2018-05-16 17:59:02 INFO::Testing a comparison of protein: 1/Rv2696c(1725 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2697c(1726 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2698(1727 of 2614)
## 2018-05-16 17:59:03 INFO::Fitting a single group.
## 2018-05-16 17:59:03 WARNING::Results of protein 1/Rv2698 for comparison cf
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2699c(1728 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2700(1729 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2701c(1730 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2702(1731 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2703(1732 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2704(1733 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2705c(1734 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2708c(1735 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2709(1736 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2710(1737 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2711(1738 of 2614)
## 
  |                                                                       
  |===========================================                      |  67%2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2713(1739 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2714(1740 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2715(1741 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2717c(1742 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2718c(1743 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2720(1744 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2721c(1745 of 2614)
## 2018-05-16 17:59:03 INFO::Testing a comparison of protein: 1/Rv2724c(1746 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2725c(1747 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2726c(1748 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2727c(1749 of 2614)
## 
  |                                                                       
  |============================================                     |  67%2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2728c(1750 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2731(1751 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2732c(1752 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2733c(1753 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2734(1754 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2737c(1755 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2738c(1756 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2739c(1757 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2740(1758 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2743c(1759 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2744c(1760 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2748c(1761 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2749(1762 of 2614)
## 2018-05-16 17:59:04 INFO::Testing a comparison of protein: 1/Rv2750(1763 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2751(1764 of 2614)
## 
  |                                                                       
  |============================================                     |  68%2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2752c(1765 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2753c(1766 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2754c(1767 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2756c(1768 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2759c(1769 of 2614)
## 2018-05-16 17:59:05 INFO::Fitting a single group.
## 2018-05-16 17:59:05 WARNING::Results of protein 1/Rv2759c for comparison cf
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2760c(1770 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2763c(1771 of 2614)
## 2018-05-16 17:59:05 INFO::Fitting a single group.
## 2018-05-16 17:59:05 WARNING::Results of protein 1/Rv2763c for comparison cf
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2764c(1772 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2765(1773 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2766c(1774 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2771c(1775 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2772c(1776 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2773c(1777 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2775(1778 of 2614)
## 2018-05-16 17:59:05 INFO::Testing a comparison of protein: 1/Rv2778c(1779 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2780(1780 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2781c(1781 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2782c(1782 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2783c(1783 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2785c(1784 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2786c(1785 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2788(1786 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2789c(1787 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2790c(1788 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2793c(1789 of 2614)
## 
  |                                                                       
  |=============================================                    |  68%2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2794c(1790 of 2614)
## 
  |                                                                       
  |=============================================                    |  69%2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2795c(1791 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2796c(1792 of 2614)
## 2018-05-16 17:59:06 WARNING::Results of protein 1/Rv2796c for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2799(1793 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2800(1794 of 2614)
## 2018-05-16 17:59:06 INFO::Fitting a single group.
## 2018-05-16 17:59:06 WARNING::Results of protein 1/Rv2800 for comparison cf
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2801c(1795 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2802c(1796 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2803(1797 of 2614)
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2808(1798 of 2614)
## 2018-05-16 17:59:06 WARNING::Results of protein 1/Rv2808 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:59:06 INFO::Testing a comparison of protein: 1/Rv2818c(1799 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2821c(1800 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2824c(1801 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2826c(1802 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2827c(1803 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2829c(1804 of 2614)
## 2018-05-16 17:59:07 INFO::Fitting a single group.
## 2018-05-16 17:59:07 WARNING::Results of protein 1/Rv2829c for comparison cf
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2831(1805 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2837c(1806 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2838c(1807 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2839c(1808 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2841c(1809 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2842c(1810 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2843(1811 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2844(1812 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2845c(1813 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2847c(1814 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2848c(1815 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2849c(1816 of 2614)
## 
  |                                                                       
  |=============================================                    |  70%2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2850c(1817 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2851c(1818 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2852c(1819 of 2614)
## 2018-05-16 17:59:07 INFO::Testing a comparison of protein: 1/Rv2854(1820 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2855(1821 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2857c(1822 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2858c(1823 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2859c(1824 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2860c(1825 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2861c(1826 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2864c(1827 of 2614)
## 2018-05-16 17:59:08 INFO::Fitting a single group.
## 2018-05-16 17:59:08 WARNING::Results of protein 1/Rv2864c for comparison cf
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2865(1828 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2868c(1829 of 2614)
## 
  |                                                                       
  |==============================================                   |  70%2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2869c(1830 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2870c(1831 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2871(1832 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2873(1833 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2875(1834 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2878c(1835 of 2614)
## 2018-05-16 17:59:08 INFO::Testing a comparison of protein: 1/Rv2882c(1836 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2883c(1837 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2887(1838 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2888c(1839 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2889c(1840 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2890c(1841 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2893(1842 of 2614)
## 
  |                                                                       
  |==============================================                   |  71%2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2895c(1843 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2899c(1844 of 2614)
## 2018-05-16 17:59:09 INFO::Fitting a single group.
## 2018-05-16 17:59:09 WARNING::Results of protein 1/Rv2899c for comparison cf
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2900c(1845 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2901c(1846 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2902c(1847 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2903c(1848 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2904c(1849 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2905(1850 of 2614)
## 2018-05-16 17:59:09 WARNING::Results of protein 1/Rv2905 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2906c(1851 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2907c(1852 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2908c(1853 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2909c(1854 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2911(1855 of 2614)
## 2018-05-16 17:59:09 INFO::Testing a comparison of protein: 1/Rv2913c(1856 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2914c(1857 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2915c(1858 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2916c(1859 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2918c(1860 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2919c(1861 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2921c(1862 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2922A(1863 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2922c(1864 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2923c(1865 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2925c(1866 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2926c(1867 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2927c(1868 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2928(1869 of 2614)
## 
  |                                                                       
  |==============================================                   |  72%2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2930(1870 of 2614)
## 
  |                                                                       
  |===============================================                  |  72%2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2931(1871 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2932(1872 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2933(1873 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2934(1874 of 2614)
## 2018-05-16 17:59:10 INFO::Fitting a single group.
## 2018-05-16 17:59:10 WARNING::Results of protein 1/Rv2934 for comparison cf
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2935(1875 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2936(1876 of 2614)
## 2018-05-16 17:59:10 INFO::Testing a comparison of protein: 1/Rv2939(1877 of 2614)
## 2018-05-16 17:59:10 INFO::Fitting a single group.
## 2018-05-16 17:59:10 WARNING::Results of protein 1/Rv2939 for comparison cf
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2940c(1878 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2941(1879 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2942(1880 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2945c(1881 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2946c(1882 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2947c(1883 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2948c(1884 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2949c(1885 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2950c(1886 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2951c(1887 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2952(1888 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2953(1889 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2954c(1890 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2955c(1891 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2956(1892 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2957(1893 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2958c(1894 of 2614)
## 2018-05-16 17:59:11 INFO::Fitting a single group.
## 2018-05-16 17:59:11 WARNING::Results of protein 1/Rv2958c for comparison cf
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2959c(1895 of 2614)
## 
  |                                                                       
  |===============================================                  |  73%2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2962c(1896 of 2614)
## 2018-05-16 17:59:11 INFO::Testing a comparison of protein: 1/Rv2965c(1897 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2966c(1898 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2967c(1899 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2969c(1900 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2970c(1901 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2971(1902 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2975a(1903 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2976c(1904 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2977c(1905 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2980(1906 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2981c(1907 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2982c(1908 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2984(1909 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2985(1910 of 2614)
## 
  |                                                                       
  |================================================                 |  73%2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2986c(1911 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2987c(1912 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2988c(1913 of 2614)
## 2018-05-16 17:59:12 INFO::Testing a comparison of protein: 1/Rv2989(1914 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2991(1915 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2992c(1916 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2993c(1917 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2995c(1918 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2996c(1919 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2997(1920 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv2999(1921 of 2614)
## 
  |                                                                       
  |================================================                 |  74%2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3001c(1922 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3002c(1923 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3003c(1924 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3004(1925 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3005c(1926 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3006(1927 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3007c(1928 of 2614)
## 2018-05-16 17:59:13 INFO::Fitting a single group.
## 2018-05-16 17:59:13 WARNING::Results of protein 1/Rv3007c for comparison cf
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3009c(1929 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3010c(1930 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3011c(1931 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3012c(1932 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3013(1933 of 2614)
## 2018-05-16 17:59:13 INFO::Testing a comparison of protein: 1/Rv3014c(1934 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3015c(1935 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3016(1936 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3024c(1937 of 2614)
## 2018-05-16 17:59:14 INFO::Fitting a single group.
## 2018-05-16 17:59:14 WARNING::Results of protein 1/Rv3024c for comparison cf
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3025c(1938 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3028c(1939 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3029c(1940 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3031(1941 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3032(1942 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3032A(1943 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3033(1944 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3034c(1945 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3035(1946 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3036c(1947 of 2614)
## 
  |                                                                       
  |================================================                 |  75%2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3037c(1948 of 2614)
## 2018-05-16 17:59:14 INFO::Fitting a single group.
## 2018-05-16 17:59:14 WARNING::Results of protein 1/Rv3037c for comparison cf
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3038c(1949 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3039c(1950 of 2614)
## 
  |                                                                       
  |=================================================                |  75%2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3040c(1951 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3041c(1952 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3042c(1953 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3043c(1954 of 2614)
## 2018-05-16 17:59:14 INFO::Testing a comparison of protein: 1/Rv3044(1955 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3045(1956 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3046c(1957 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3048c(1958 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3049c(1959 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3050c(1960 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3051c(1961 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3052c(1962 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3053c(1963 of 2614)
## 2018-05-16 17:59:15 INFO::Fitting a single group.
## 2018-05-16 17:59:15 WARNING::Results of protein 1/Rv3053c for comparison cf
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3054c(1964 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3055(1965 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3057c(1966 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3058c(1967 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3059(1968 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3061c(1969 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3062(1970 of 2614)
## 2018-05-16 17:59:15 INFO::Testing a comparison of protein: 1/Rv3068c(1971 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3071(1972 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3075c(1973 of 2614)
## 
  |                                                                       
  |=================================================                |  76%2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3077(1974 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3079c(1975 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3080c(1976 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3081(1977 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3082c(1978 of 2614)
## 2018-05-16 17:59:16 INFO::Fitting a single group.
## 2018-05-16 17:59:16 WARNING::Results of protein 1/Rv3082c for comparison cf
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3083(1979 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3084(1980 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3085(1981 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3086(1982 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3087(1983 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3088(1984 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3089(1985 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3090(1986 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3091(1987 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3092c(1988 of 2614)
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3093c(1989 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3094c(1990 of 2614)
## 
  |                                                                       
  |==================================================               |  76%2018-05-16 17:59:16 INFO::Testing a comparison of protein: 1/Rv3096(1991 of 2614)
## 2018-05-16 17:59:16 WARNING::Results of protein 1/Rv3096 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3099c(1992 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3101c(1993 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3102c(1994 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3104c(1995 of 2614)
## 2018-05-16 17:59:17 INFO::Fitting a single group.
## 2018-05-16 17:59:17 WARNING::Results of protein 1/Rv3104c for comparison cf
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3105c(1996 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3106(1997 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3107c(1998 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3116(1999 of 2614)
## 
  |                                                                       
  |==================================================               |  77%2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3119(2000 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3120(2001 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3121(2002 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3130c(2003 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3132c(2004 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3133c(2005 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3134c(2006 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3136(2007 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3137(2008 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3139(2009 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3140(2010 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3141(2011 of 2614)
## 2018-05-16 17:59:17 INFO::Testing a comparison of protein: 1/Rv3143(2012 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3144c(2013 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3145(2014 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3146(2015 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3147(2016 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3148(2017 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3149(2018 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3150(2019 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3151(2020 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3152(2021 of 2614)
## 2018-05-16 17:59:18 INFO::Fitting a single group.
## 2018-05-16 17:59:18 WARNING::Results of protein 1/Rv3152 for comparison cf
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3153(2022 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3154(2023 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3155(2024 of 2614)
## 2018-05-16 17:59:18 INFO::Fitting a single group.
## 2018-05-16 17:59:18 WARNING::Results of protein 1/Rv3155 for comparison cf
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3156(2025 of 2614)
## 
  |                                                                       
  |==================================================               |  78%2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3157(2026 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3158(2027 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3160c(2028 of 2614)
## 2018-05-16 17:59:18 INFO::Testing a comparison of protein: 1/Rv3161c(2029 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3164c(2030 of 2614)
## 
  |                                                                       
  |===================================================              |  78%2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3167c(2031 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3168(2032 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3169(2033 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3170(2034 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3179(2035 of 2614)
## 2018-05-16 17:59:19 INFO::Fitting a single group.
## 2018-05-16 17:59:19 WARNING::Results of protein 1/Rv3179 for comparison cf
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3181c(2036 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3189(2037 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3190A(2038 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3190c(2039 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3193c(2040 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3194c(2041 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3196A(2042 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3197(2043 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3198A(2044 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3198c(2045 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3200c(2046 of 2614)
## 2018-05-16 17:59:19 INFO::Testing a comparison of protein: 1/Rv3203(2047 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3205c(2048 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3206c(2049 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3207c(2050 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3208(2051 of 2614)
## 
  |                                                                       
  |===================================================              |  79%2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3208A(2052 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3210c(2053 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3211(2054 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3212(2055 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3213c(2056 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3214(2057 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3215(2058 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3218(2059 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3220c(2060 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3221A(2061 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3223c(2062 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3224(2063 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3225c(2064 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3226c(2065 of 2614)
## 2018-05-16 17:59:20 INFO::Testing a comparison of protein: 1/Rv3227(2066 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3228(2067 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3229c(2068 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3230c(2069 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3231c(2070 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3232c(2071 of 2614)
## 
  |                                                                       
  |====================================================             |  79%2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3233c(2072 of 2614)
## 2018-05-16 17:59:21 INFO::Fitting a single group.
## 2018-05-16 17:59:21 WARNING::Results of protein 1/Rv3233c for comparison cf
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3234c(2073 of 2614)
## 2018-05-16 17:59:21 INFO::Fitting a single group.
## 2018-05-16 17:59:21 WARNING::Results of protein 1/Rv3234c for comparison cf
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3237c(2074 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3240c(2075 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3241c(2076 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3243c(2077 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3244c(2078 of 2614)
## 
  |                                                                       
  |====================================================             |  80%2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3245c(2079 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3246c(2080 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3247c(2081 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3248c(2082 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3249c(2083 of 2614)
## 2018-05-16 17:59:21 INFO::Testing a comparison of protein: 1/Rv3253c(2084 of 2614)
## 2018-05-16 17:59:21 INFO::Fitting a single group.
## 2018-05-16 17:59:21 WARNING::Results of protein 1/Rv3253c for comparison cf
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3254(2085 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3255c(2086 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3256c(2087 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3257c(2088 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3259(2089 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3260c(2090 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3261(2091 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3262(2092 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3264c(2093 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3265c(2094 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3266c(2095 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3267(2096 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3268(2097 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3269(2098 of 2614)
## 2018-05-16 17:59:22 INFO::Testing a comparison of protein: 1/Rv3270(2099 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3271c(2100 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3272(2101 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3273(2102 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3274c(2103 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3275c(2104 of 2614)
## 
  |                                                                       
  |====================================================             |  81%2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3276c(2105 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3278c(2106 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3279c(2107 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3280(2108 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3281(2109 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3282(2110 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3283(2111 of 2614)
## 
  |                                                                       
  |=====================================================            |  81%2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3284(2112 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3285(2113 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3286c(2114 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3287c(2115 of 2614)
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3290c(2116 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:23 INFO::Testing a comparison of protein: 1/Rv3291c(2117 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3292(2118 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3293(2119 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3295(2120 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3296(2121 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3297(2122 of 2614)
## 2018-05-16 17:59:24 INFO::Fitting a single group.
## 2018-05-16 17:59:24 WARNING::Results of protein 1/Rv3297 for comparison cf
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3298c(2123 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3299c(2124 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3301c(2125 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3302c(2126 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3303c(2127 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3304(2128 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3305c(2129 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3306c(2130 of 2614)
## 
  |                                                                       
  |=====================================================            |  82%2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3307(2131 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3308(2132 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3309c(2133 of 2614)
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3310(2134 of 2614)
## 2018-05-16 17:59:24 WARNING::Results of protein 1/Rv3310 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:24 INFO::Testing a comparison of protein: 1/Rv3311(2135 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3312A(2136 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3313c(2137 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3314c(2138 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3315c(2139 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3317(2140 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3318(2141 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3319(2142 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3321c(2143 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3322c(2144 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3329(2145 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3330(2146 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3332(2147 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3336c(2148 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3339c(2149 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3340(2150 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3341(2151 of 2614)
## 
  |                                                                       
  |======================================================           |  82%2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3342(2152 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3356c(2153 of 2614)
## 2018-05-16 17:59:25 INFO::Testing a comparison of protein: 1/Rv3357(2154 of 2614)
## 2018-05-16 17:59:25 WARNING::Results of protein 1/Rv3357 for comparison cf are NA because there are measurements only in group delta_whole
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3359(2155 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3360(2156 of 2614)
## 2018-05-16 17:59:26 INFO::Fitting a single group.
## 2018-05-16 17:59:26 WARNING::Results of protein 1/Rv3360 for comparison cf
## 
  |                                                                       
  |======================================================           |  83%2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3362c(2157 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3364c(2158 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3365c(2159 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3368c(2160 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3369(2161 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3372(2162 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3373(2163 of 2614)
## 2018-05-16 17:59:26 INFO::Fitting a single group.
## 2018-05-16 17:59:26 WARNING::Results of protein 1/Rv3373 for comparison cf
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3375(2164 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3376(2165 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3377c(2166 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3384c(2167 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3389c(2168 of 2614)
## 2018-05-16 17:59:26 INFO::Testing a comparison of protein: 1/Rv3390(2169 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3391(2170 of 2614)
## 2018-05-16 17:59:27 INFO::Fitting a single group.
## 2018-05-16 17:59:27 WARNING::Results of protein 1/Rv3391 for comparison cf
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3392c(2171 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3393(2172 of 2614)
## 2018-05-16 17:59:27 INFO::Fitting a single group.
## 2018-05-16 17:59:27 WARNING::Results of protein 1/Rv3393 for comparison cf
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3395A(2173 of 2614)
## 2018-05-16 17:59:27 WARNING::Results of protein 1/Rv3395A for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3396c(2174 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3399(2175 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3400(2176 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3401(2177 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3404c(2178 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3405c(2179 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3407(2180 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3408(2181 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3409c(2182 of 2614)
## 
  |                                                                       
  |======================================================           |  84%2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3410c(2183 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3411c(2184 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3412(2185 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3413c(2186 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3417c(2187 of 2614)
## 2018-05-16 17:59:27 INFO::Testing a comparison of protein: 1/Rv3418c(2188 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3419c(2189 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3422c(2190 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3423c(2191 of 2614)
## 
  |                                                                       
  |=======================================================          |  84%2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3432c(2192 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3433c(2193 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3435c(2194 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3436c(2195 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3437(2196 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3438(2197 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3441c(2198 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3442c(2199 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3443c(2200 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3451(2201 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3452(2202 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3455c(2203 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3456c(2204 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3457c(2205 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3458c(2206 of 2614)
## 2018-05-16 17:59:28 INFO::Testing a comparison of protein: 1/Rv3459c(2207 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3460c(2208 of 2614)
## 
  |                                                                       
  |=======================================================          |  85%2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3461c(2209 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3462c(2210 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3463(2211 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3464(2212 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3465(2213 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3472(2214 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3477(2215 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3478(2216 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3479(2217 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3480c(2218 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3482c(2219 of 2614)
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3483c(2220 of 2614)
## 2018-05-16 17:59:29 INFO::Fitting a single group.
## 2018-05-16 17:59:29 WARNING::Results of protein 1/Rv3483c for comparison cf
## 2018-05-16 17:59:29 INFO::Testing a comparison of protein: 1/Rv3484(2221 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3485c(2222 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3487c(2223 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3488(2224 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3489(2225 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3490(2226 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3492c(2227 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3493c(2228 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3494c(2229 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3495c(2230 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3496c(2231 of 2614)
## 
  |                                                                       
  |========================================================         |  85%2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3497c(2232 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3498c(2233 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3499c(2234 of 2614)
## 
  |                                                                       
  |========================================================         |  86%2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3500c(2235 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3501c(2236 of 2614)
## 2018-05-16 17:59:30 INFO::Fitting a single group.
## 2018-05-16 17:59:30 WARNING::Results of protein 1/Rv3501c for comparison cf
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3502c(2237 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3503c(2238 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3504(2239 of 2614)
## 2018-05-16 17:59:30 INFO::Testing a comparison of protein: 1/Rv3505(2240 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3509c(2241 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3510c(2242 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3515c(2243 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3516(2244 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3517(2245 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3518c(2246 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3519(2247 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3520c(2248 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3522(2249 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3523(2250 of 2614)
## 2018-05-16 17:59:31 INFO::Fitting a single group.
## 2018-05-16 17:59:31 WARNING::Results of protein 1/Rv3523 for comparison cf
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3524(2251 of 2614)
## 2018-05-16 17:59:31 WARNING::Results of protein 1/Rv3524 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3526(2252 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3528c(2253 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3529c(2254 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3534c(2255 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3535c(2256 of 2614)
## 2018-05-16 17:59:31 INFO::Testing a comparison of protein: 1/Rv3536c(2257 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3537(2258 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3540c(2259 of 2614)
## 2018-05-16 17:59:32 INFO::Fitting a single group.
## 2018-05-16 17:59:32 WARNING::Results of protein 1/Rv3540c for comparison cf
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3542c(2260 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3543c(2261 of 2614)
## 
  |                                                                       
  |========================================================         |  87%2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3544c(2262 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3545c(2263 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3546(2264 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3547(2265 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3548c(2266 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3550(2267 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3554(2268 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3556c(2269 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3559c(2270 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3560c(2271 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3561(2272 of 2614)
## 
  |                                                                       
  |=========================================================        |  87%2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3562(2273 of 2614)
## 2018-05-16 17:59:32 INFO::Testing a comparison of protein: 1/Rv3564(2274 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3566c(2275 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3568c(2276 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3569c(2277 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3570c(2278 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3571(2279 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3572(2280 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3573c(2281 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3574(2282 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3575c(2283 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3576(2284 of 2614)
## 2018-05-16 17:59:33 INFO::Fitting a single group.
## 2018-05-16 17:59:33 WARNING::Results of protein 1/Rv3576 for comparison cf
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3577(2285 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3579c(2286 of 2614)
## 2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3580c(2287 of 2614)
## 
  |                                                                       
  |=========================================================        |  88%2018-05-16 17:59:33 INFO::Testing a comparison of protein: 1/Rv3581c(2288 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3582c(2289 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3583c(2290 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3584(2291 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3586(2292 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3587c(2293 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3588c(2294 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3589(2295 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3591c(2296 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3592(2297 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3593(2298 of 2614)
## 2018-05-16 17:59:34 INFO::Fitting a single group.
## 2018-05-16 17:59:34 WARNING::Results of protein 1/Rv3593 for comparison cf
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3596c(2299 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3597c(2300 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3598c(2301 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3600c(2302 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3601c(2303 of 2614)
## 2018-05-16 17:59:34 INFO::Fitting a single group.
## 2018-05-16 17:59:34 WARNING::Results of protein 1/Rv3601c for comparison cf
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3602c(2304 of 2614)
## 2018-05-16 17:59:34 INFO::Testing a comparison of protein: 1/Rv3604c(2305 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3606c(2306 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3607c(2307 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3608c(2308 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3609c(2309 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3610c(2310 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3614c(2311 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3615c(2312 of 2614)
## 
  |                                                                       
  |==========================================================       |  88%2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3616c(2313 of 2614)
## 
  |                                                                       
  |==========================================================       |  89%2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3617(2314 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3618(2315 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3623(2316 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3624c(2317 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3625c(2318 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3626c(2319 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3627c(2320 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3628(2321 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3631(2322 of 2614)
## 2018-05-16 17:59:35 INFO::Testing a comparison of protein: 1/Rv3632(2323 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3633(2324 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3634c(2325 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3644c(2326 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3645(2327 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3646c(2328 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3647c(2329 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3648c(2330 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3651(2331 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3661(2332 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3662c(2333 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3663c(2334 of 2614)
## 2018-05-16 17:59:36 INFO::Fitting a single group.
## 2018-05-16 17:59:36 WARNING::Results of protein 1/Rv3663c for comparison cf
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3666c(2335 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3667(2336 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3669(2337 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3670(2338 of 2614)
## 2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3671c(2339 of 2614)
## 
  |                                                                       
  |==========================================================       |  90%2018-05-16 17:59:36 INFO::Testing a comparison of protein: 1/Rv3672c(2340 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3673c(2341 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3674c(2342 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3675(2343 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3676(2344 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3677c(2345 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3678A(2346 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3678c(2347 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3679(2348 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3680(2349 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3682(2350 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3683(2351 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3684(2352 of 2614)
## 
  |                                                                       
  |===========================================================      |  90%2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3685c(2353 of 2614)
## 2018-05-16 17:59:37 INFO::Testing a comparison of protein: 1/Rv3687c(2354 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3688c(2355 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3690(2356 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3691(2357 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3692(2358 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3693(2359 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3695(2360 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3696c(2361 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3697A(2362 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3699(2363 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3700c(2364 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3701c(2365 of 2614)
## 
  |                                                                       
  |===========================================================      |  91%2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3702c(2366 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3703c(2367 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3705c(2368 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3708c(2369 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3709c(2370 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3710(2371 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3713(2372 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3715c(2373 of 2614)
## 2018-05-16 17:59:38 INFO::Testing a comparison of protein: 1/Rv3716c(2374 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3717(2375 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3718c(2376 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3719(2377 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3720(2378 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3721c(2379 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3722c(2380 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3723(2381 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3726(2382 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3729(2383 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3730c(2384 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3731(2385 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3732(2386 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3734c(2387 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3736(2388 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3737(2389 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3744(2390 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3747(2391 of 2614)
## 
  |                                                                       
  |===========================================================      |  92%2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3753c(2392 of 2614)
## 
  |                                                                       
  |============================================================     |  92%2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3754(2393 of 2614)
## 2018-05-16 17:59:39 INFO::Testing a comparison of protein: 1/Rv3755c(2394 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3758c(2395 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3759c(2396 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3761c(2397 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3762c(2398 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3763(2399 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3764c(2400 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3765c(2401 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3766(2402 of 2614)
## 2018-05-16 17:59:40 WARNING::Results of protein 1/Rv3766 for comparison cf are NA because there are measurements only in group comp_whole
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3767c(2403 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3768(2404 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3772(2405 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3773c(2406 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3774(2407 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3775(2408 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3777(2409 of 2614)
## 2018-05-16 17:59:40 INFO::Testing a comparison of protein: 1/Rv3778c(2410 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3779(2411 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3780(2412 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3781(2413 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3782(2414 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3784(2415 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3786c(2416 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3787c(2417 of 2614)
## 2018-05-16 17:59:41 INFO::Fitting a single group.
## 2018-05-16 17:59:41 WARNING::Results of protein 1/Rv3787c for comparison cf
## 
  |                                                                       
  |============================================================     |  93%2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3788(2418 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3790(2419 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3791(2420 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3792(2421 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3793(2422 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3794(2423 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3795(2424 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3796(2425 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3797(2426 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3799c(2427 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3800c(2428 of 2614)
## 2018-05-16 17:59:41 INFO::Testing a comparison of protein: 1/Rv3801c(2429 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3802c(2430 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3803c(2431 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3804c(2432 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3805c(2433 of 2614)
## 
  |                                                                       
  |=============================================================    |  93%2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3806c(2434 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3808c(2435 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3809c(2436 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3813c(2437 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3814c(2438 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3815c(2439 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3816c(2440 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3817(2441 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3818(2442 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3819(2443 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3820c(2444 of 2614)
## 
  |                                                                       
  |=============================================================    |  94%2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3822(2445 of 2614)
## 2018-05-16 17:59:42 WARNING::Results of protein 1/Rv3822 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3824c(2446 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3825c(2447 of 2614)
## 2018-05-16 17:59:42 INFO::Testing a comparison of protein: 1/Rv3826(2448 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3834c(2449 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3835(2450 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3836(2451 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3837c(2452 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3838c(2453 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3841(2454 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3842c(2455 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3843c(2456 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3846(2457 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3849(2458 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3850(2459 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3852(2460 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3853(2461 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3854c(2462 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3855(2463 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3856c(2464 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3858c(2465 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3859c(2466 of 2614)
## 2018-05-16 17:59:43 INFO::Testing a comparison of protein: 1/Rv3860(2467 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3863(2468 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3864(2469 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3865(2470 of 2614)
## 
  |                                                                       
  |=============================================================    |  95%2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3866(2471 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3867(2472 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3868(2473 of 2614)
## 
  |                                                                       
  |==============================================================   |  95%2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3869(2474 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3870(2475 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3871(2476 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3872(2477 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3873(2478 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3874(2479 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3875(2480 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3876(2481 of 2614)
## 2018-05-16 17:59:44 INFO::Testing a comparison of protein: 1/Rv3878(2482 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3879c(2483 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3880c(2484 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3881c(2485 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3882c(2486 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3883c(2487 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3884c(2488 of 2614)
## 2018-05-16 17:59:45 INFO::Fitting a single group.
## 2018-05-16 17:59:45 WARNING::Results of protein 1/Rv3884c for comparison cf
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3885c(2489 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3886c(2490 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3887c(2491 of 2614)
## 2018-05-16 17:59:45 INFO::Fitting a single group.
## 2018-05-16 17:59:45 WARNING::Results of protein 1/Rv3887c for comparison cf
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3888c(2492 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3890c(2493 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3891c(2494 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3894c(2495 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3895c(2496 of 2614)
## 
  |                                                                       
  |==============================================================   |  96%2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3902c(2497 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3907c(2498 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3908(2499 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3909(2500 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3910(2501 of 2614)
## 2018-05-16 17:59:45 INFO::Testing a comparison of protein: 1/Rv3913(2502 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3914(2503 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3915(2504 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3916c(2505 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3917c(2506 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3918c(2507 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3919c(2508 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3920c(2509 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3921c(2510 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3922c(2511 of 2614)
## 2018-05-16 17:59:46 INFO::Fitting a single group.
## 2018-05-16 17:59:46 WARNING::Results of protein 1/Rv3922c for comparison cf
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3923c(2512 of 2614)
## 2018-05-16 17:59:46 INFO::Fitting a single group.
## 2018-05-16 17:59:46 WARNING::Results of protein 1/Rv3923c for comparison cf
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 1/Rv3924c(2513 of 2614)
## 
  |                                                                       
  |===============================================================  |  96%2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0073/Rv2564(2514 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0107c/Rv1415(2515 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0327c/Rv3240c(2516 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0386/Rv0890c(2517 of 2614)
## 2018-05-16 17:59:46 INFO::Fitting a single group.
## 2018-05-16 17:59:46 WARNING::Results of protein 2/Rv0386/Rv0890c for comparison cf
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0469/Rv0645c(2518 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0593/Rv0173(2519 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0645c/Rv0469(2520 of 2614)
## 2018-05-16 17:59:46 INFO::Testing a comparison of protein: 2/Rv0893c/Rv0281(2521 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1039c/Rv0387c(2522 of 2614)
## 2018-05-16 17:59:47 INFO::Fitting a single group.
## 2018-05-16 17:59:47 WARNING::Results of protein 2/Rv1039c/Rv0387c for comparison cf
## 
  |                                                                       
  |===============================================================  |  97%2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1135c/Rv0878c(2523 of 2614)
## 2018-05-16 17:59:47 INFO::Fitting a single group.
## 2018-05-16 17:59:47 WARNING::Results of protein 2/Rv1135c/Rv0878c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1181/Rv2940c(2524 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1253/Rv3366(2525 of 2614)
## 2018-05-16 17:59:47 INFO::Fitting a single group.
## 2018-05-16 17:59:47 WARNING::Results of protein 2/Rv1253/Rv3366 for comparison cf
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1281c/Rv2713(2526 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1320c/Rv1318c(2527 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1361c/Rv1196(2528 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1467c/Rv0244c(2529 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1526c/Rv1524(2530 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1529/Rv1521(2531 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1630/Rv1564c(2532 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1661/Rv2048c(2533 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1662/Rv2048c(2534 of 2614)
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1674c/Rv3295(2535 of 2614)
## 2018-05-16 17:59:47 INFO::Fitting a single group.
## 2018-05-16 17:59:47 WARNING::Results of protein 2/Rv1674c/Rv3295 for comparison cf
## 2018-05-16 17:59:47 INFO::Testing a comparison of protein: 2/Rv1695/Rv3285(2536 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1729c/Rv0725c(2537 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1736c/Rv1161(2538 of 2614)
## 2018-05-16 17:59:48 INFO::Fitting a single group.
## 2018-05-16 17:59:48 WARNING::Results of protein 2/Rv1736c/Rv1161 for comparison cf
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1736c/Rv1164(2539 of 2614)
## 2018-05-16 17:59:48 INFO::Fitting a single group.
## 2018-05-16 17:59:48 WARNING::Results of protein 2/Rv1736c/Rv1164 for comparison cf
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1760/Rv1595(2540 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1771/Rv0706(2541 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1797/Rv0667(2542 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1821/Rv3240c(2543 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv1945/Rv1148c(2544 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2048c/Rv1661(2545 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2115c/Rv0435c(2546 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2223c/Rv2224c(2547 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2284/Rv1426c(2548 of 2614)
## 2018-05-16 17:59:48 INFO::Fitting a single group.
## 2018-05-16 17:59:48 WARNING::Results of protein 2/Rv2284/Rv1426c for comparison cf
## 
  |                                                                       
  |===============================================================  |  98%2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2346c/Rv1793(2549 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2351c/Rv2350c(2550 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2564/Rv0073(2551 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2590/Rv0101(2552 of 2614)
## 2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2643/Rv3120(2553 of 2614)
## 
  |                                                                       
  |================================================================ |  98%2018-05-16 17:59:48 INFO::Testing a comparison of protein: 2/Rv2650c/Rv1576c(2554 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2703/Rv2710(2555 of 2614)
## 2018-05-16 17:59:49 INFO::Fitting a single group.
## 2018-05-16 17:59:49 WARNING::Results of protein 2/Rv2703/Rv2710 for comparison cf
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2828c/Rv2825c(2556 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2931/Rv2932(2557 of 2614)
## 2018-05-16 17:59:49 INFO::Fitting a single group.
## 2018-05-16 17:59:49 WARNING::Results of protein 2/Rv2931/Rv2932 for comparison cf
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2932/Rv2931(2558 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2933/Rv2932(2559 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2940c/Rv1181(2560 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2940c/Rv1527c(2561 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2947c/Rv2048c(2562 of 2614)
## 2018-05-16 17:59:49 INFO::Fitting a single group.
## 2018-05-16 17:59:49 WARNING::Results of protein 2/Rv2947c/Rv2048c for comparison cf
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2949c/Rv3436c(2563 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2953/Rv2449c(2564 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2956/Rv1513(2565 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2962c/Rv3596c(2566 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv2974c/Rv1213(2567 of 2614)
## 2018-05-16 17:59:49 INFO::Fitting a single group.
## 2018-05-16 17:59:49 WARNING::Results of protein 2/Rv2974c/Rv1213 for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3022A/Rv0285(2568 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3034c/Rv0777(2569 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3049c/Rv0892(2570 of 2614)
## 2018-05-16 17:59:49 INFO::Fitting a single group.
## 2018-05-16 17:59:49 WARNING::Results of protein 2/Rv3049c/Rv0892 for comparison cf
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3083/Rv0565c(2571 of 2614)
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3083/Rv3854c(2572 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 2018-05-16 17:59:49 INFO::Testing a comparison of protein: 2/Rv3117/Rv0815c(2573 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3118/Rv0814c(2574 of 2614)
## 
  |                                                                       
  |================================================================ |  99%2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3132c/Rv2027c(2575 of 2614)
## 2018-05-16 17:59:50 INFO::Fitting a single group.
## 2018-05-16 17:59:50 WARNING::Results of protein 2/Rv3132c/Rv2027c for comparison cf
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3182/Rv2022c(2576 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3375/Rv2838c(2577 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3392c/Rv0470c(2578 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3392c/Rv0642c(2579 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3399/Rv0145(2580 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3417c/Rv0440(2581 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3478/Rv1361c(2582 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3480c/Rv2285(2583 of 2614)
## 2018-05-16 17:59:50 INFO::Fitting a single group.
## 2018-05-16 17:59:50 WARNING::Results of protein 2/Rv3480c/Rv2285 for comparison cf
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3515c/Rv3513c(2584 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3533c/Rv3159c(2585 of 2614)
## 2018-05-16 17:59:50 INFO::Fitting a single group.
## 2018-05-16 17:59:50 WARNING::Results of protein 2/Rv3533c/Rv3159c for comparison cf
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3596c/Rv0384c(2586 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3692/Rv1479(2587 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3767c/Rv1729c(2588 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3804c/Rv1886c(2589 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3825c/Rv1181(2590 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3825c/Rv1527c(2591 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3826/Rv2941(2592 of 2614)
## 2018-05-16 17:59:50 INFO::Testing a comparison of protein: 2/Rv3833/Rv1925(2593 of 2614)
## 
  |                                                                       
  |=================================================================|  99%2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv0644c/Rv0643c/Rv0470c(2594 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv0748/Rv0277A/Rv3393(2595 of 2614)
## 2018-05-16 17:59:51 INFO::Fitting a single group.
## 2018-05-16 17:59:51 WARNING::Results of protein 3/Rv0748/Rv0277A/Rv3393 for comparison cf
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv1131/Rv0896/Rv0889c(2596 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv1320c/Rv1319c/Rv1318c(2597 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv1361c/Rv1196/Rv3478(2598 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv1529/Rv1521/Rv2930(2599 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv2015c/Rv1765c/Rv3031(2600 of 2614)
## Warning in summary.lm(obj): essentially perfect fit: summary may be
## unreliable
## 
  |                                                                       
  |=================================================================| 100%2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv2351c/Rv2350c/Rv2349c(2601 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv2933/Rv2932/Rv2931(2602 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv2941/Rv1529/Rv1521(2603 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv3121/Rv2266/Rv0212c(2604 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv3392c/Rv0503c/Rv0470c(2605 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv3392c/Rv0644c/Rv0643c(2606 of 2614)
## 2018-05-16 17:59:51 INFO::Testing a comparison of protein: 3/Rv3767c/Rv0726c/Rv0146(2607 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 3/Rv3798/Rv1313c/Rv2984(2608 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 3/Rv3825c/Rv2940c/Rv1181(2609 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 4/Rv2932/Rv2931/Rv2823c/Rv3566c(2610 of 2614)
## 2018-05-16 17:59:52 WARNING::Results of protein 4/Rv2932/Rv2931/Rv2823c/Rv3566c for comparison cf are NA because there are no measurements in both conditions.
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 4/Rv3140/Rv1297/Rv0549c/Rv2308(2611 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 4/Rv3826/Rv2941/Rv1529/Rv1521(2612 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 5/Rv3619c/Rv2346c/Rv1793/Rv1198/Rv1037c(2613 of 2614)
## 2018-05-16 17:59:52 INFO::Testing a comparison of protein: 5/Rv3620c/Rv2347c/Rv1792/Rv1197/Rv1038c(2614 of 2614)
## 
## 2018-05-16 17:59:52 INFO::Comparisons for all proteins are finished.
## 2018-05-16 17:59:52 INFO::Adjusted p-values are calculated.
## 2018-05-16 17:59:52 INFO::Group comparison is complete.

3.1.1 P/PE protein QC plots for Yan

Yan asked for the p/pe protein qc plots. ok. I changed the dataProcessPlots to return something useful, so that should be possible now.

pe_genes <- read.table("reference/annotated_pe_genes.txt")[[1]]

## Unfortunately, the names did not get set in my changed version of dataProcessPlots...
plotlst <- msstats_plots$QCPLOT
available_plots <- gsub(pattern="^1/", replacement="", x=levels(msstats_quant$ProcessedData$PROTEIN))
names(plotlst) <- available_plots

pe_in_avail_idx <- pe_genes %in% available_plots
pe_in_avail <- pe_genes[pe_in_avail_idx]
pe_plots <- plotlst[pe_in_avail]
pdf(file="pe_qc_plots.pdf")
for (p in 1:length(pe_plots)) {
  plot(pe_plots[[p]])
}
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Warning: Removed 7 rows containing non-finite values (stat_boxplot).
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Warning: Removed 20 rows containing non-finite values (stat_boxplot).
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Warning: Removed 8 rows containing non-finite values (stat_boxplot).
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Warning: Removed 39 rows containing non-finite values (stat_boxplot).
## Warning: Removed 11 rows containing non-finite values (stat_boxplot).
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Warning: Removed 32 rows containing non-finite values (stat_boxplot).
## Warning: Removed 10 rows containing non-finite values (stat_boxplot).
## Warning: Removed 4 rows containing non-finite values (stat_boxplot).
## Warning: Removed 12 rows containing non-finite values (stat_boxplot).
## Warning: Removed 6 rows containing non-finite values (stat_boxplot).

## Warning: Removed 6 rows containing non-finite values (stat_boxplot).

## Warning: Removed 6 rows containing non-finite values (stat_boxplot).
## Warning: Removed 13 rows containing non-finite values (stat_boxplot).
## Warning: Removed 25 rows containing non-finite values (stat_boxplot).
## Warning: Removed 15 rows containing non-finite values (stat_boxplot).
## Warning: Removed 31 rows containing non-finite values (stat_boxplot).
## Warning: Removed 5 rows containing non-finite values (stat_boxplot).
## Warning: Removed 3 rows containing non-finite values (stat_boxplot).
## Warning: Removed 1 rows containing non-finite values (stat_boxplot).
## Warning: Removed 14 rows containing non-finite values (stat_boxplot).
dev.off()
## png 
##   2

4 Create hpgltools expressionset

Since I am not certain I understand these data, I will take the intensities from SWATH2stats, metadata, and annotation data; attempt to create a ‘normal’ expressionset; poke at it to see what I can learn.

4.1 Massaging the metadata

I want to use the same metadata as were used for MSstats. It has a few important differences from the requirements of hpgltools: pretty much only that I do not allow rownames/sampleIDs to start with a number.

metadata <- sample_annot
metadata[["sampleid"]] <- paste0("s", metadata[["sampleid"]])
rownames(metadata) <- metadata[["sampleid"]]

4.2 Massaging the gene annotation data and adding the msstats data.

I have my own annotation data from the gff file/microbesonline/whatever, I can add the MSstats result to it so that later I can print them all together.

## Here is a neat little thing I can do:  Add the MSstats results to my annotation data.
## Then when I print out the tables of the limma/etc results, they MSstats
## results will come along for free.
msstats_table <- first_msstats_comparison[["ComparisonResult"]]
rownames(msstats_table) <- gsub(pattern="^1\\/", replacement="",
                                x=msstats_table[["Protein"]])
mtb_annotations_with_msstats <- merge(mtb_annotations, msstats_table,
                                      by="row.names", all.x=TRUE)
rownames(mtb_annotations_with_msstats) <- mtb_annotations_with_msstats[["Row.names"]]
mtb_annotations_with_msstats <- mtb_annotations_with_msstats[, -1]

4.3 Massaging the intensity matrix

I do not want the \1 before the protein names, I already merged them into one entry per gene vis SWATH2stats.

prot_mtrx <- read.csv("swath2stats_protein_all_201805.csv")
rownames(prot_mtrx) <- gsub(pattern="^1\\/", replacement="", x=prot_mtrx[["proteinname"]])
prot_mtrx <- prot_mtrx[, -1]
## Important question: Did SWATH2stats reorder my data?
fun <- gsub(pattern="^.*_(2018.*$)", replacement="\\1", x=colnames(prot_mtrx))
colnames(prot_mtrx) <- paste0("s", fun)

decoy_idx <- ! grepl(pattern="DECOY", x=rownames(prot_mtrx))
prot_mtrx <- prot_mtrx[decoy_idx, ]

prot_mtrx_modified <- prot_mtrx
zero_idx <- prot_mtrx == 0
prot_mtrx_modified[zero_idx] <- 2

4.4 Merge the pieces

Now we should have sufficient pieces to make an expressionset.

## Drop the metadata not in the protein matrix:
## And ensure that they are the same order.
reordered <- colnames(prot_mtrx)
metadata <- metadata[reordered, ]

protein_expt <- create_expt(metadata,
                            count_dataframe=prot_mtrx,
                            gene_info=mtb_annotations_with_msstats)
## Reading the sample metadata.
## The sample definitions comprises: 12, 17 rows, columns.
## Matched 2499 annotations and counts.
## Bringing together the count matrix and gene information.
## Some annotations were lost in merging, setting them to 'undefined'.
protein_metrics <- sm(graph_metrics(protein_expt))
protein_norm <- sm(normalize_expt(protein_expt, transform="log2", convert="cpm",
                                  norm="quant", filter=TRUE))
protein_norm_metrics <- sm(graph_metrics(protein_norm))
protein_metrics$libsize

protein_norm_metrics$pcaplot
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse

5 Attempt some quantification comparisons?

pairwise_filt <- sm(normalize_expt(protein_expt, filter=TRUE))
pairwise_comp <- all_pairwise(pairwise_filt, parallel=FALSE, force=TRUE)
## There is just one batch in this data.
## Using limma's removeBatchEffect to visualize before/after batch inclusion.
## There is just one batch in this data.
## Starting limma pairwise comparison.
## Leaving the data alone, regardless of normalization state.
## libsize was not specified, this parameter has profound effects on limma's result.
## Using the libsize from expt$best_libsize.
## Limma step 1/6: choosing model.
## The condition+batch model failed.  Does your experimental design support
## both condition and batch? Using only a conditional model.
## Choosing the non-intercept containing model.
## Limma step 2/6: running limma::voom(), switch with the argument 'which_voom'.
## Using normalize.method=quantile for voom.
## Limma step 3/6: running lmFit with method: ls.
## Limma step 4/6: making and fitting contrasts with no intercept. (~ 0 + factors)
## Limma step 5/6: Running eBayes with robust=FALSE and trend=FALSE.
## Limma step 6/6: Writing limma outputs.
## Limma step 6/6: 1/6: Creating table: comp_whole_vs_comp_cf.  Adjust=BH
## Limma step 6/6: 2/6: Creating table: delta_cf_vs_comp_cf.  Adjust=BH
## Limma step 6/6: 3/6: Creating table: delta_whole_vs_comp_cf.  Adjust=BH
## Limma step 6/6: 4/6: Creating table: delta_cf_vs_comp_whole.  Adjust=BH
## Limma step 6/6: 5/6: Creating table: delta_whole_vs_comp_whole.  Adjust=BH
## Limma step 6/6: 6/6: Creating table: delta_whole_vs_delta_cf.  Adjust=BH
## Limma step 6/6: 1/4: Creating table: comp_cf.  Adjust=BH
## Limma step 6/6: 2/4: Creating table: comp_whole.  Adjust=BH
## Limma step 6/6: 3/4: Creating table: delta_cf.  Adjust=BH
## Limma step 6/6: 4/4: Creating table: delta_whole.  Adjust=BH
## Starting DESeq2 pairwise comparisons.
## About to round the data, this is a pretty terrible thing to do. But if you,
## like me, want to see what happens when you put non-standard data into deseq, then here you go.
## Warning in choose_binom_dataset(input, force = force): This data was
## inappropriately forced into integers.
## The condition+batch model failed.  Does your experimental design support
## both condition and batch? Using only a conditional model.
## Choosing the non-intercept containing model.
## DESeq2 step 1/5: Including batch and condition in the deseq model.
## Warning in import_deseq(data, column_data, model_string, tximport =
## input[["tximport"]][["raw"]]): Converted down 73 elements because they are
## larger than the maximum integer size.
## converting counts to integer mode
## DESeq2 step 2/5: Estimate size factors.
## DESeq2 step 3/5: Estimate dispersions.
## gene-wise dispersion estimates
## mean-dispersion relationship
## final dispersion estimates
## Using a parametric fitting seems to have worked.
## DESeq2 step 4/5: nbinomWaldTest.
## Plotting dispersions.

## 
  |                                                                       
  |                                                                 |   0%
  |                                                                       
  |===========                                                      |  17%
  |                                                                       
  |======================                                           |  33%
  |                                                                       
  |================================                                 |  50%
  |                                                                       
  |===========================================                      |  67%
  |                                                                       
  |======================================================           |  83%
  |                                                                       
  |=================================================================| 100%
## Starting edgeR pairwise comparisons.
## About to round the data, this is a pretty terrible thing to do. But if you,
## like me, want to see what happens when you put non-standard data into deseq, then here you go.
## Warning in choose_binom_dataset(input, force = force): This data was
## inappropriately forced into integers.
## The condition+batch model failed.  Does your experimental design support
## both condition and batch? Using only a conditional model.
## Choosing the non-intercept containing model.
## EdgeR step 1/9: importing and normalizing data.
## EdgeR step 2/9: Estimating the common dispersion.
## EdgeR step 3/9: Estimating dispersion across genes.
## EdgeR step 4/9: Estimating GLM Common dispersion.
## EdgeR step 5/9: Estimating GLM Trended dispersion.
## EdgeR step 6/9: Estimating GLM Tagged dispersion.
## EdgeR step 7/9: Running glmFit, switch to glmQLFit by changing the argument 'edger_test'.
## EdgeR step 8/9: Making pairwise contrasts.

## 
  |                                                                       
  |                                                                 |   0%
  |                                                                       
  |===========                                                      |  17%
  |                                                                       
  |======================                                           |  33%
  |                                                                       
  |================================                                 |  50%
  |                                                                       
  |===========================================                      |  67%
  |                                                                       
  |======================================================           |  83%
  |                                                                       
  |=================================================================| 100%
## Starting basic pairwise comparison.
## Leaving the data alone, regardless of normalization state.
## Basic step 0/3: Transforming data.
## Basic step 1/3: Creating median and variance tables.
## Basic step 2/3: Performing 10 comparisons.
## 
  |                                                                       
  |                                                                 |   0%
  |                                                                       
  |===========                                                      |  17%
  |                                                                       
  |======================                                           |  33%
  |                                                                       
  |================================                                 |  50%
  |                                                                       
  |===========================================                      |  67%
  |                                                                       
  |======================================================           |  83%
  |                                                                       
  |=================================================================| 100%
## Basic step 3/3: Creating faux DE Tables.
## Basic: Returning tables.
## Comparing analyses 1/6: comp_whole_vs_comp_cf
## Comparing analyses 2/6: delta_cf_vs_comp_cf
## Comparing analyses 3/6: delta_whole_vs_comp_cf
## Comparing analyses 4/6: delta_cf_vs_comp_whole
## Comparing analyses 5/6: delta_whole_vs_comp_whole
## Comparing analyses 6/6: delta_whole_vs_delta_cf

keepers <- list("filtrate_vs_cells" = c("wt_cf", "wt_whole"))
pairwise_tables <- combine_de_tables(pairwise_comp,
                                     excel="excel/test_pairwise_de_with_msstats.xlsx",
                                     keepers=keepers)
## Writing a legend of columns.
## Printing a pca plot before/after surrogates/batch estimation.
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## The keepers has no elements in the coefficients.
## Here are the keepers: wt_cf, wt_whole
## Here are the coefficients: comp_whole, comp_cf, delta_cf, comp_cf, delta_whole, comp_cf, delta_cf, comp_whole, delta_whole, comp_whole, delta_whole, delta_cf
## Error in combine_de_tables(pairwise_comp, excel = "excel/test_pairwise_de_with_msstats.xlsx", : Unable to find the set of contrasts to keep, fix this and try again.
droppers <- c("undefined")
names(droppers) <- "log2fc"
pairwise_onlyall <- combine_de_tables(pairwise_comp,
                                      excel="excel/test_pairwise_de_only_msstats.xlsx",
                                      keepers=keepers,
                                      excludes=droppers)
## Deleting the file excel/test_pairwise_de_only_msstats.xlsx before writing the tables.
## Writing a legend of columns.
## Printing a pca plot before/after surrogates/batch estimation.
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## Too few points to calculate an ellipse
## The keepers has no elements in the coefficients.
## Here are the keepers: wt_cf, wt_whole
## Here are the coefficients: comp_whole, comp_cf, delta_cf, comp_cf, delta_whole, comp_cf, delta_cf, comp_whole, delta_whole, comp_whole, delta_whole, delta_cf
## Error in combine_de_tables(pairwise_comp, excel = "excel/test_pairwise_de_only_msstats.xlsx", : Unable to find the set of contrasts to keep, fix this and try again.
pairwise_sig <- sm(extract_significant_genes(pairwise_tables,
                                             excel="excel/test_pairwise_sig_with_msstats.xlsx"))
## Error in extract_significant_genes(pairwise_tables, excel = "excel/test_pairwise_sig_with_msstats.xlsx"): object 'pairwise_tables' not found
solo_proteins <- features_in_single_condition(protein_expt)
proteins_only_cf <- solo_proteins[["solo_this"]][["wt_cf"]]
proteins_only_cf
## NULL
proteins_only_whole <- solo_proteins[["solo_this"]][["wt_whole"]]
length(proteins_only_whole)
## [1] 0
pairwise_modified_comp <- all_pairwise(protein_modified_expt, parallel=FALSE, force=TRUE)
## Error in normalize_expt(input, filter = TRUE, batch = FALSE, transform = "log2", : object 'protein_modified_expt' not found
pairwise_modified_tables <- combine_de_tables(pairwise_modified_comp,
                                              excel="excel/test_pairwise_modified_de_with_msstats.xlsx",
                                              keepers=keepers)
## Error in combine_de_tables(pairwise_modified_comp, excel = "excel/test_pairwise_modified_de_with_msstats.xlsx", : object 'pairwise_modified_comp' not found
droppers <- c("undefined")
names(droppers) <- "log2fc"
pairwise_modified_onlyall <- combine_de_tables(pairwise_modified_comp,
                                               excel="excel/test_pairwise_de_only_msstats.xlsx",
                                               keepers=keepers,
                                               excludes=droppers)
## Error in combine_de_tables(pairwise_modified_comp, excel = "excel/test_pairwise_de_only_msstats.xlsx", : object 'pairwise_modified_comp' not found
pairwise_modified_sig <- sm(extract_significant_genes(
  pairwise_modified_tables,
  excel="excel/test_pairwise_modified_sig_with_msstats.xlsx"))
## Error in extract_significant_genes(pairwise_modified_tables, excel = "excel/test_pairwise_modified_sig_with_msstats.xlsx"): object 'pairwise_modified_tables' not found

5.1 Compare hpgltools/MSstats

Can we compare limma and riends to MSstats?

hpgl_table <- pairwise_tables$data[[1]]
## Error in eval(expr, envir, enclos): object 'pairwise_tables' not found
msstats_table <- msstats_comparison$ComparisonResult
## Error in eval(expr, envir, enclos): object 'msstats_comparison' not found
rownames(msstats_table) <- gsub(pattern="^1/", replacement="", x=msstats_table$Protein)

merged_table <- merge(hpgl_table, msstats_table, by="row.names")
## Error in merge(hpgl_table, msstats_table, by = "row.names"): object 'hpgl_table' not found
write.csv(file="images/merged_table.csv", merged_table)
## Error in is.data.frame(x): object 'merged_table' not found
cor.test(merged_table$limma_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$limma_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$limma_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$limma_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
cor.test(merged_table$deseq_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$deseq_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$deseq_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$deseq_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
cor.test(merged_table$edger_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$edger_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$edger_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$edger_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
combined_table <- pairwise_tables$data[[1]]
## Error in eval(expr, envir, enclos): object 'pairwise_tables' not found
undefined_idx <- combined_table[["log2fc"]] == "undefined"
## Error in eval(expr, envir, enclos): object 'combined_table' not found
combined_table[undefined_idx, "log2fc"] <- NA
## Error in combined_table[undefined_idx, "log2fc"] <- NA: object 'combined_table' not found
combined_table[["log2fc"]] <- as.numeric(combined_table[["log2fc"]])
## Error in eval(expr, envir, enclos): object 'combined_table' not found
cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]])
## Error in cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]]): object 'combined_table' not found
cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]], method="spearman")
## Error in cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]], : object 'combined_table' not found
high_to_low_idx <- order(combined_table[["log2fc"]], na.last=TRUE, decreasing=TRUE)
## Error in order(combined_table[["log2fc"]], na.last = TRUE, decreasing = TRUE): object 'combined_table' not found
low_to_high_idx <- order(combined_table[["log2fc"]], na.last=TRUE, decreasing=FALSE)
## Error in order(combined_table[["log2fc"]], na.last = TRUE, decreasing = FALSE): object 'combined_table' not found
top_50 <- head(combined_table[high_to_low_idx, ], n=100)
## Error in head(combined_table[high_to_low_idx, ], n = 100): object 'combined_table' not found
bottom_50 <- head(combined_table[low_to_high_idx, ], n=100)
## Error in head(combined_table[low_to_high_idx, ], n = 100): object 'combined_table' not found
cor.test(top_50$limma_logfc, top_50$log2fc)
## Error in cor.test(top_50$limma_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$limma_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$limma_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(top_50$deseq_logfc, top_50$log2fc)
## Error in cor.test(top_50$deseq_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$deseq_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$deseq_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(top_50$edger_logfc, top_50$log2fc)
## Error in cor.test(top_50$edger_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$edger_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$edger_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(bottom_50$limma_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$limma_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$limma_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$limma_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
cor.test(bottom_50$deseq_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$deseq_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$deseq_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$deseq_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
cor.test(bottom_50$edger_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$edger_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$edger_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$edger_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
up_in_msstats <- rownames(combined_table)[combined_table[["log2fc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_msstats <- up_in_msstats[!is.na(up_in_msstats)]
## Error in eval(expr, envir, enclos): object 'up_in_msstats' not found
up_in_limma <- rownames(combined_table)[combined_table[["limma_logfc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_limma <- up_in_limma[!is.na(up_in_limma)]
## Error in eval(expr, envir, enclos): object 'up_in_limma' not found
up_in_edger <- rownames(combined_table)[combined_table[["edger_logfc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_edger <- up_in_edger[!is.na(up_in_edger)]
## Error in eval(expr, envir, enclos): object 'up_in_edger' not found
up_venn_sets <- list(
  "msstats" = up_in_msstats,
  "limma" = up_in_limma,
  "edger" = up_in_edger)
## Error in eval(expr, envir, enclos): object 'up_in_msstats' not found
testing <- Vennerable::Venn(Sets=up_venn_sets, )
## Error in Vennerable::Venn(Sets = up_venn_sets, ): object 'up_venn_sets' not found
pp(file="/tmp/up_venn.png")
## Going to write the image to: /tmp/up_venn.png when dev.off() is called.
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
dev.off()
## png 
##   2
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
down_in_msstats <- rownames(combined_table)[combined_table[["log2fc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_msstats <- down_in_msstats[!is.na(down_in_msstats)]
## Error in eval(expr, envir, enclos): object 'down_in_msstats' not found
down_in_limma <- rownames(combined_table)[combined_table[["limma_logfc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_limma <- down_in_limma[!is.na(down_in_limma)]
## Error in eval(expr, envir, enclos): object 'down_in_limma' not found
down_in_edger <- rownames(combined_table)[combined_table[["edger_logfc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_edger <- down_in_edger[!is.na(down_in_edger)]
## Error in eval(expr, envir, enclos): object 'down_in_edger' not found
down_venn_sets <- list(
  "msstats" = down_in_msstats,
  "limma" = down_in_limma,
  "edger" = down_in_edger)
## Error in eval(expr, envir, enclos): object 'down_in_msstats' not found
testing <- Vennerable::Venn(Sets=down_venn_sets, )
## Error in Vennerable::Venn(Sets = down_venn_sets, ): object 'down_venn_sets' not found
pp(file="/tmp/down_venn.png")
## Going to write the image to: /tmp/down_venn.png when dev.off() is called.
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
dev.off()
## png 
##   2

6 Repeat with the modified data

hpgl_table <- pairwise_modified_tables$data[[1]]
## Error in eval(expr, envir, enclos): object 'pairwise_modified_tables' not found
msstats_table <- msstats_modified_comp$ComparisonResult
## Error in eval(expr, envir, enclos): object 'msstats_modified_comp' not found
rownames(msstats_table) <- gsub(pattern="^1/", replacement="", x=msstats_table_modified$Protein)
## Error in gsub(pattern = "^1/", replacement = "", x = msstats_table_modified$Protein): object 'msstats_table_modified' not found
merged_table <- merge(hpgl_table, msstats_table, by="row.names")
## Error in merge(hpgl_table, msstats_table, by = "row.names"): object 'hpgl_table' not found
write.csv(file="images/merged_table_modified.csv", merged_table)
## Error in is.data.frame(x): object 'merged_table' not found
cor.test(merged_table$limma_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$limma_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$limma_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$limma_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
cor.test(merged_table$deseq_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$deseq_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$deseq_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$deseq_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
cor.test(merged_table$edger_logfc, merged_table$log2FC)
## Error in cor.test(merged_table$edger_logfc, merged_table$log2FC): object 'merged_table' not found
cor.test(merged_table$edger_logfc, merged_table$log2FC, method="spearman")
## Error in cor.test(merged_table$edger_logfc, merged_table$log2FC, method = "spearman"): object 'merged_table' not found
combined_table <- pairwise_tables$data[[1]]
## Error in eval(expr, envir, enclos): object 'pairwise_tables' not found
undefined_idx <- combined_table[["log2fc"]] == "undefined"
## Error in eval(expr, envir, enclos): object 'combined_table' not found
combined_table[undefined_idx, "log2fc"] <- NA
## Error in combined_table[undefined_idx, "log2fc"] <- NA: object 'combined_table' not found
combined_table[["log2fc"]] <- as.numeric(combined_table[["log2fc"]])
## Error in eval(expr, envir, enclos): object 'combined_table' not found
cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]])
## Error in cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]]): object 'combined_table' not found
cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]], method="spearman")
## Error in cor.test(combined_table[["limma_logfc"]], combined_table[["log2fc"]], : object 'combined_table' not found
high_to_low_idx <- order(combined_table[["log2fc"]], na.last=TRUE, decreasing=TRUE)
## Error in order(combined_table[["log2fc"]], na.last = TRUE, decreasing = TRUE): object 'combined_table' not found
low_to_high_idx <- order(combined_table[["log2fc"]], na.last=TRUE, decreasing=FALSE)
## Error in order(combined_table[["log2fc"]], na.last = TRUE, decreasing = FALSE): object 'combined_table' not found
top_50 <- head(combined_table[high_to_low_idx, ], n=100)
## Error in head(combined_table[high_to_low_idx, ], n = 100): object 'combined_table' not found
bottom_50 <- head(combined_table[low_to_high_idx, ], n=100)
## Error in head(combined_table[low_to_high_idx, ], n = 100): object 'combined_table' not found
cor.test(top_50$limma_logfc, top_50$log2fc)
## Error in cor.test(top_50$limma_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$limma_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$limma_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(top_50$deseq_logfc, top_50$log2fc)
## Error in cor.test(top_50$deseq_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$deseq_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$deseq_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(top_50$edger_logfc, top_50$log2fc)
## Error in cor.test(top_50$edger_logfc, top_50$log2fc): object 'top_50' not found
cor.test(top_50$edger_logfc, top_50$log2fc, method="spearman")
## Error in cor.test(top_50$edger_logfc, top_50$log2fc, method = "spearman"): object 'top_50' not found
cor.test(bottom_50$limma_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$limma_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$limma_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$limma_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
cor.test(bottom_50$deseq_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$deseq_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$deseq_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$deseq_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
cor.test(bottom_50$edger_logfc, bottom_50$log2fc)
## Error in cor.test(bottom_50$edger_logfc, bottom_50$log2fc): object 'bottom_50' not found
cor.test(bottom_50$edger_logfc, bottom_50$log2fc, method="spearman")
## Error in cor.test(bottom_50$edger_logfc, bottom_50$log2fc, method = "spearman"): object 'bottom_50' not found
up_in_msstats <- rownames(combined_table)[combined_table[["log2fc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_msstats <- up_in_msstats[!is.na(up_in_msstats)]
## Error in eval(expr, envir, enclos): object 'up_in_msstats' not found
up_in_limma <- rownames(combined_table)[combined_table[["limma_logfc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_limma <- up_in_limma[!is.na(up_in_limma)]
## Error in eval(expr, envir, enclos): object 'up_in_limma' not found
up_in_edger <- rownames(combined_table)[combined_table[["edger_logfc"]] > 0]
## Error in rownames(combined_table): object 'combined_table' not found
up_in_edger <- up_in_edger[!is.na(up_in_edger)]
## Error in eval(expr, envir, enclos): object 'up_in_edger' not found
up_venn_sets <- list(
  "msstats" = up_in_msstats,
  "limma" = up_in_limma,
  "edger" = up_in_edger)
## Error in eval(expr, envir, enclos): object 'up_in_msstats' not found
testing <- Vennerable::Venn(Sets=up_venn_sets, )
## Error in Vennerable::Venn(Sets = up_venn_sets, ): object 'up_venn_sets' not found
pp(file="/tmp/up_venn.png")
## Going to write the image to: /tmp/up_venn.png when dev.off() is called.
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
dev.off()
## png 
##   2
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
down_in_msstats <- rownames(combined_table)[combined_table[["log2fc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_msstats <- down_in_msstats[!is.na(down_in_msstats)]
## Error in eval(expr, envir, enclos): object 'down_in_msstats' not found
down_in_limma <- rownames(combined_table)[combined_table[["limma_logfc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_limma <- down_in_limma[!is.na(down_in_limma)]
## Error in eval(expr, envir, enclos): object 'down_in_limma' not found
down_in_edger <- rownames(combined_table)[combined_table[["edger_logfc"]] < 0]
## Error in rownames(combined_table): object 'combined_table' not found
down_in_edger <- down_in_edger[!is.na(down_in_edger)]
## Error in eval(expr, envir, enclos): object 'down_in_edger' not found
down_venn_sets <- list(
  "msstats" = down_in_msstats,
  "limma" = down_in_limma,
  "edger" = down_in_edger)
## Error in eval(expr, envir, enclos): object 'down_in_msstats' not found
testing <- Vennerable::Venn(Sets=down_venn_sets, )
## Error in Vennerable::Venn(Sets = down_venn_sets, ): object 'down_venn_sets' not found
pp(file="/tmp/down_venn.png")
## Going to write the image to: /tmp/down_venn.png when dev.off() is called.
Vennerable::plot(testing, doWeights=FALSE)
## Error in Vennerable::plot(testing, doWeights = FALSE): object 'testing' not found
dev.off()
## png 
##   2

7 Everything below here might get dropped?

I think I wedged all of the following work into that short block above. So, stop evaluating the following blocks and see if that is true.

7.0.1 Expressionset from the TRIC intensity matrix

intensity_mtrx <- read.csv(file="results/tric/HCD_outmatrix.tsv", sep="\t")
## The HCD_outmatrix has columns including: Peptide, Protein,
## A series of Intensity_sample_id columns
## A series of RT_sample_id columns
## A series of score_sample_id columns
## And at the end: RT_mean, RT_std, and pg_pvalue.
## Since SWATH2stats/MSstats uses the intensities, lets get those columns out,
## standardize the column names to match the annotation data, and use them for
## creating an expressionset.
intensity_mtrx[["rownames"]] <- intensity_mtrx[["Protein"]]
intensity_mtrx[["rownames"]] <- gsub(pattern="^[[:digit:]]+\\/",
                                     replacement="", x=intensity_mtrx[["rownames"]])
## Standardize the rownames, this might be a bad idea, as this will keep
## separate every peptide from each protein and not do anything to
## sum/median/whatever them.  But for the purposes of testing out the data I
## think it is ok.
rownames(intensity_mtrx) <- make.names(intensity_mtrx[["rownames"]], unique=TRUE)

## Now lets get rid of the extraneous text in the column names and simplify them
## to the sample names as referenced in the sample sheet.
all_columns <- colnames(intensity_mtrx)
intense_columns <- grepl(pattern="Intensity", x=all_columns)
intensity_mtrx <- intensity_mtrx[, intense_columns]
all_columns <- colnames(intensity_mtrx)
new_columns <- gsub(pattern="Intensity_", replacement="", x=all_columns)
new_columns <- gsub(pattern="_dia_.*$", replacement="", x=new_columns)
colnames(intensity_mtrx) <- paste0("s", new_columns)
intensity_mtrx[is.na(intensity_mtrx)] <- 0

## No columns in an expression set are allowed to start with a number.  I have
## unsed prefixing samples with 's' as a standard to handle this problem...
metadata <- sample_annot
metadata$sampleid <- paste0("s", metadata$sampleid)
colnames(intensity_mtrx) <- gsub(pattern="_vs_HCD", replacement="", x=colnames(intensity_mtrx))
rownames(metadata) <- metadata$sampleid
## Theoretically this is not needed anymore...
intensity_mtrx <- intensity_mtrx[, rownames(metadata)]
## Ok, at this point, we should have all the pieces for a more or less normal expressionset.
dim(intensity_mtrx)
test_expt <- create_expt(metadata=metadata,
                         count_dataframe=intensity_mtrx,
                         gene_info=mtb_annotations)

7.0.2 Play with the hpgltools derived expressionset of peptide intensities

Lets see if anything makes sense in this intensity expressionset.

## First, log2 and normalize the data.
test_norm <- normalize_expt(test_expt, transform="log2", convert="cpm", norm="quantile", filter=TRUE)
test_normbatch <- sm(normalize_expt(test_expt, transform="log2", convert="cpm",
                                    norm="quantile", filter=TRUE, batch="limma"))

test_metrics <- sm(graph_metrics(test_expt))
test_metrics_norm <- sm(graph_metrics(test_norm))
test_metrics_normbatch <- sm(graph_metrics(test_normbatch))

Now lets see what the data looks like, assuming I did not do anything horrible to it.

test_metrics$legend
test_metrics$libsize  ## Wow the intensities get ridiculous, what?
test_metrics$nonzero
## Interesting, but nothing which super-jumps out at me
test_metrics$density
## hmm very interesting, the good news is that they all have basically the same
## distribution.  I did not expect the CF samples to have such a stronger
## distribution though.

test_metrics_norm$corheat
## This suggests to me a likely batch effect
test_metrics_norm$disheat
test_metrics$smc
test_metrics$tsneplot
## Yeah there is some wonkyness between the old/new samples.

test_metrics_normbatch$pcaplot
## Wow, this is after invoking 'removeBatchEffect' from limma.  That suggests
## pretty strongly to me that we should probalby not examine the new and old
## data together.  In addition I am thinking that one whole-cell lysate sample
## might not be.

7.1 Remove old batch/weirdo sample

kept_testing <- subset_expt(test_expt,
                            subset="bioreplicate == 'mar'")
## The new batch IDs: x,y,z are associated with the 3 runs of these samples, one
## which is 8 m/z, one which is 20 m/z, and one which is a reordered 20 m/z.

test_norm <- normalize_expt(kept_testing, transform="log2", convert="cpm", norm="quantile", filter=TRUE)
test_normbatch <- sm(normalize_expt(kept_testing, transform="log2", convert="cpm",
                                    filter=TRUE, batch="limma"))
new_metrics <- sm(graph_metrics(kept_testing))
new_metrics_norm <- sm(graph_metrics(test_norm))
new_metrics_normbatch <- sm(graph_metrics(test_normbatch))

7.1.1 Plot only new data

Removing the January data seems to have made this a lot easier to look at. There might be some batchyness associated with reordering the samples, but I am thinking it is not huge.

tt = plot_topn(kept_testing, direct=TRUE)
new_metrics$legend
new_metrics$libsize
pp("images/kept_norm_topn.png", image=new_metrics$topnplot)
pp("images/kept_norm_hcd_pca.png", image=new_metrics_norm$pcaplot)
new_metrics_norm$tsneplot
pp("images/kept_norm_hcd_corheat.png", image=new_metrics_norm$corheat)
new_metrics_norm$disheat
new_metrics_normbatch$pcaplot
pp("images/normbatch_tsne.png", image=new_metrics_normbatch$tsneplot)

7.1.2 How is the variance?

Lets see what variancePartition has to say about this data.

new_varpart <- varpart(kept_testing, factors=c("condition", "batch"))
pp("images/varpart_partition.png", image=new_varpart$partition_plot)
## That is not terrible.

## the modified_expt slow from varpart() adds some metadata to the expressionset
## including the calculated % variance for condition/batch/residual for each peptide.
kept_testing <- new_varpart$modified_expt

7.2 Back to hpgltools

If you will recall, in the original block where I read the data into SWATH2stats, I invoked write_matrix_proteins() and write_matrix_peptides() and wrote out 2 csv files ‘swath2stats_protein_matrix.csv’ and ’_peptide_matrix.csv’. If my earlier work is correct, I should be able to use the protein matrix to get a truer sense of the relative abundances between my experimental conditions.

library(aLFQ)
alfq_process <- ProteinInference(alfq_input,
                                 peptide_method="top",
                                 peptide_topx=3,
                                 peptide_strictness="loose",
                                 peptide_summary="mean",
                                 transition_topx=3,
                                 transition_strictness="loose",
                                 transition_summary="sum",
                                 fasta=NA,
                                 model=NA,
                                 combine_precursors=FALSE)

8 Index version: 20180215

9 TODO

  • 2018-04-10: Make sure my invocations of SWATH2stats/MSstats are correct.
if (!isTRUE(get0("skip_load"))) {
  message(paste0("This is hpgltools commit: ", get_git_commit()))
  this_save <- paste0(gsub(pattern="\\.Rmd", replace="", x=rmd_file), "-v", ver, ".rda.xz")
  message(paste0("Saving to ", this_save))
  tmp <- sm(saveme(filename=this_save))
  pander::pander(sessionInfo())
}
## If you wish to reproduce this exact build of hpgltools, invoke the following:
## > git clone http://github.com/abelew/hpgltools.git
## > git reset 30a7620d2c8178ee096ea68cb80ebb90d3ed9966
## R> packrat::restore()
## This is hpgltools commit: Tue May 15 16:49:55 2018 -0400: 30a7620d2c8178ee096ea68cb80ebb90d3ed9966
## Saving to 02_swath2stats_201805-v20180215.rda.xz

R version 3.4.4 (2018-03-15)

Platform: x86_64-pc-linux-gnu (64-bit)

locale: LC_CTYPE=en_US.utf8, LC_NUMERIC=C, LC_TIME=en_US.utf8, LC_COLLATE=en_US.utf8, LC_MONETARY=en_US.utf8, LC_MESSAGES=en_US.utf8, LC_PAPER=en_US.utf8, LC_NAME=C, LC_ADDRESS=C, LC_TELEPHONE=C, LC_MEASUREMENT=en_US.utf8 and LC_IDENTIFICATION=C

attached base packages: stats, graphics, grDevices, utils, datasets, methods and base

other attached packages: edgeR(v.3.20.9), ruv(v.0.9.7), MSstats(v.3.10.2), SWATH2stats(v.1.9.1) and hpgltools(v.2018.03)

loaded via a namespace (and not attached): Rtsne(v.0.13), minqa(v.1.2.4), colorspace(v.1.3-2), rprojroot(v.1.3-2), htmlTable(v.1.11.2), XVector(v.0.18.0), corpcor(v.1.6.9), GenomicRanges(v.1.30.3), base64enc(v.0.1-3), Vennerable(v.3.1.0.9000), rstudioapi(v.0.7), roxygen2(v.6.0.1), mzR(v.2.12.0), affyio(v.1.48.0), ggrepel(v.0.7.0), bit64(v.0.9-7), AnnotationDbi(v.1.40.0), xml2(v.1.2.0), codetools(v.0.2-15), splines(v.3.4.4), logging(v.0.7-103), doParallel(v.1.0.11), impute(v.1.52.0), geneplotter(v.1.56.0), knitr(v.1.20), Formula(v.1.2-3), nloptr(v.1.0.4), annotate(v.1.56.2), cluster(v.2.0.7-1), vsn(v.3.46.0), graph(v.1.56.0), compiler(v.3.4.4), backports(v.1.1.2), assertthat(v.0.2.0), Matrix(v.1.2-14), lazyeval(v.0.2.1), limma(v.3.34.9), acepack(v.1.4.1), htmltools(v.0.3.6), tools(v.3.4.4), bindrcpp(v.0.2.2), GenomeInfoDbData(v.1.0.0), gtable(v.0.2.0), glue(v.1.2.0), affy(v.1.56.0), reshape2(v.1.4.3), dplyr(v.0.7.4), Rcpp(v.0.12.16), MALDIquant(v.1.17), Biobase(v.2.38.0), gdata(v.2.18.0), preprocessCore(v.1.40.0), nlme(v.3.1-137), iterators(v.1.0.9), stringr(v.1.3.0), openxlsx(v.4.0.17), testthat(v.2.0.0), lme4(v.1.1-17), gtools(v.3.5.0), devtools(v.1.13.5), XML(v.3.98-1.11), directlabels(v.2017.03.31), zlibbioc(v.1.24.0), MASS(v.7.3-50), scales(v.0.5.0.9000), MSnbase(v.2.4.2), BiocInstaller(v.1.28.0), pcaMethods(v.1.70.0), doSNOW(v.1.0.16), ProtGenerics(v.1.10.0), RBGL(v.1.54.0), SummarizedExperiment(v.1.8.1), parallel(v.3.4.4), RColorBrewer(v.1.1-2), yaml(v.2.1.19), memoise(v.1.1.0), gridExtra(v.2.3), pander(v.0.6.1), ggplot2(v.2.2.1), rpart(v.4.1-13), latticeExtra(v.0.6-28), stringi(v.1.2.2), RSQLite(v.2.1.0), highr(v.0.6), genefilter(v.1.60.0), S4Vectors(v.0.16.0), foreach(v.1.4.4), checkmate(v.1.8.5), caTools(v.1.17.1), BiocGenerics(v.0.24.0), BiocParallel(v.1.12.0), GenomeInfoDb(v.1.14.0), rlang(v.0.2.0.9001), pkgconfig(v.2.0.1), commonmark(v.1.5), bitops(v.1.0-6), matrixStats(v.0.53.1), mzID(v.1.16.0), evaluate(v.0.10.1), lattice(v.0.20-35), bindr(v.0.1.1), htmlwidgets(v.1.2), labeling(v.0.3), bit(v.1.1-12), plyr(v.1.8.4), magrittr(v.1.5), DESeq2(v.1.18.1), R6(v.2.2.2), Hmisc(v.4.1-1), IRanges(v.2.12.0), snow(v.0.4-2), gplots(v.3.0.1), DelayedArray(v.0.4.1), DBI(v.1.0.0), foreign(v.0.8-70), pillar(v.1.2.2), withr(v.2.1.2), mgcv(v.1.8-23), nnet(v.7.3-12), survival(v.2.42-3), RCurl(v.1.95-4.10), tibble(v.1.4.2), KernSmooth(v.2.23-15), rmarkdown(v.1.9), locfit(v.1.5-9.1), grid(v.3.4.4), sva(v.3.26.0), minpack.lm(v.1.2-1), data.table(v.1.11.0), marray(v.1.56.0), blob(v.1.1.1), digest(v.0.6.15), xtable(v.1.8-2), stats4(v.3.4.4), munsell(v.0.4.3) and quadprog(v.1.5-5)

LS0tCnRpdGxlOiAiTS50dWJlcmN1bG9zaXMgMjAxODA1OiBBbmFseXppbmcgZGF0YSBmcm9tIE9wZW5Td2F0aFdvcmtGbG93L1RSSUMuIgphdXRob3I6ICJhdGIgYWJlbGV3QGdtYWlsLmNvbSIKZGF0ZTogImByIFN5cy5EYXRlKClgIgpvdXRwdXQ6CiBodG1sX2RvY3VtZW50OgogIGNvZGVfZG93bmxvYWQ6IHRydWUKICBjb2RlX2ZvbGRpbmc6IHNob3cKICBmaWdfY2FwdGlvbjogdHJ1ZQogIGZpZ19oZWlnaHQ6IDcKICBmaWdfd2lkdGg6IDcKICBoaWdobGlnaHQ6IGRlZmF1bHQKICBrZWVwX21kOiBmYWxzZQogIG1vZGU6IHNlbGZjb250YWluZWQKICBudW1iZXJfc2VjdGlvbnM6IHRydWUKICBzZWxmX2NvbnRhaW5lZDogdHJ1ZQogIHRoZW1lOiByZWFkYWJsZQogIHRvYzogdHJ1ZQogIHRvY19mbG9hdDoKICAgIGNvbGxhcHNlZDogZmFsc2UKICAgIHNtb290aF9zY3JvbGw6IGZhbHNlCi0tLQoKPHN0eWxlPgogIGJvZHkgLm1haW4tY29udGFpbmVyIHsKICAgIG1heC13aWR0aDogMTYwMHB4OwogIH0KPC9zdHlsZT4KCmBgYHtyIG9wdGlvbnMsIGluY2x1ZGU9RkFMU0V9CmlmICghaXNUUlVFKGdldDAoInNraXBfbG9hZCIpKSkgewogIGxpYnJhcnkoaHBnbHRvb2xzKQogIHR0IDwtIGRldnRvb2xzOjpsb2FkX2FsbCgifi9ocGdsdG9vbHMiKQogIGtuaXRyOjpvcHRzX2tuaXQkc2V0KHByb2dyZXNzPVRSVUUsCiAgICAgICAgICAgICAgICAgICAgICAgdmVyYm9zZT1UUlVFLAogICAgICAgICAgICAgICAgICAgICAgIHdpZHRoPTkwLAogICAgICAgICAgICAgICAgICAgICAgIGVjaG89VFJVRSkKICBrbml0cjo6b3B0c19jaHVuayRzZXQoZXJyb3I9VFJVRSwKICAgICAgICAgICAgICAgICAgICAgICAgZmlnLndpZHRoPTgsCiAgICAgICAgICAgICAgICAgICAgICAgIGZpZy5oZWlnaHQ9OCwKICAgICAgICAgICAgICAgICAgICAgICAgZHBpPTk2KQogIG9sZF9vcHRpb25zIDwtIG9wdGlvbnMoZGlnaXRzPTQsCiAgICAgICAgICAgICAgICAgICAgICAgICBzdHJpbmdzQXNGYWN0b3JzPUZBTFNFLAogICAgICAgICAgICAgICAgICAgICAgICAga25pdHIuZHVwbGljYXRlLmxhYmVsPSJhbGxvdyIpCiAgZ2dwbG90Mjo6dGhlbWVfc2V0KGdncGxvdDI6OnRoZW1lX2J3KGJhc2Vfc2l6ZT0xMCkpCiAgdmVyIDwtICIyMDE4MDIxNSIKICBwcmV2aW91c19maWxlIDwtICIwMV9wcmVwcm9jZXNzaW5nX2NvbWV0X2hpZ2hyZXMuUm1kIgoKICB0bXAgPC0gdHJ5KHNtKGxvYWRtZShmaWxlbmFtZT1wYXN0ZTAoZ3N1YihwYXR0ZXJuPSJcXC5SbWQiLCByZXBsYWNlPSIiLCB4PXByZXZpb3VzX2ZpbGUpLCAiLXYiLCB2ZXIsICIucmRhLnh6IikpKSkKICBwcmV2aW91c19maWxlIDwtICIwMV9hbm5vdGF0aW9uLlJtZCIKICB0bXAgPC0gdHJ5KHNtKGxvYWRtZShmaWxlbmFtZT1wYXN0ZTAoZ3N1YihwYXR0ZXJuPSJcXC5SbWQiLCByZXBsYWNlPSIiLCB4PXByZXZpb3VzX2ZpbGUpLCAiLXYiLCB2ZXIsICIucmRhLnh6IikpKSkKCiAgcm1kX2ZpbGUgPC0gIjAyX3N3YXRoMnN0YXRzXzIwMTgwNS5SbWQiCn0KYGBgCgojIFRPRE8KCiogUmVtb3ZlIE1Tc3RhdHMgbG9nZ2luZy4gLS0gZG9uZQoqIE1ha2UgZXhwbGljaXQgc3BlYXJtYW4gY29ycmVsYXRpb25zIGJldHdlZW4gbWV0aG9kcy4gLS0gZG9uZQogICAgKiBEbyBib3RoIGZvciBhbGwgZGF0YSBhbmQgZm9yIHRoZSB0b3AtNTAvYm90dG9tLTUwIC0tIGRvbmUsIGJ1dCB3ZWlyZC4KKiBNYWtlIDEwMCUgY2VydGFpbiB0aGF0IHRoZSBzYW1wbGVzIGFyZSBhbm5vdGF0ZWQgY29ycmVjdGx5LiAtLSBkb25lLgoqIExpbW1hL01Tc3RhdHMvRWRnZVIgdmVubiBkaXNhZ3JhbSBmb3IgYWxsIHVwIGluIENGCiAgICogUmVwZWF0IGluIGFsbCBkb3duIENGCiAgICogUmVwZWF0IHdpdGggYSBjdXRvZmYsIHRvcC01MAoqIEluZGl2aWR1YWwgcGxvdHMgZm9yIFAvUEUgcHJvdGVpbnMuCgpBbmFseXppbmcgZGF0YSBmcm9tIG9wZW5NUyBhbmQgZnJpZW5kcy4KPT09PT09PT09PT09PT09PT09PT09PT09PT09PT09PT09PT09PT09CgpJbiBwcmVwcm9jZXNzaW5nX2NvbWV0X2hpZ2hyZXMuUm1kLCBJIHVzZWQgdGhlIG9wZW5NUyB0dXRvcmlhbHMgYW5kIHN1cHBsZW1lbnRhbAptYXRlcmlhbHMgZnJvbSBhIGNvdXBsZSBwYXBlcnMgdG8gaG9wZWZ1bGx5IGNvcnJlY3RseSBwZXJmb3JtIHRoZSB2YXJpb3VzCnByZXByb2Nlc3NpbmcgdGFza3MgcmVxdWlyZWQgdG8gZXh0cmFjdCBpbnRlbnNpdHkgZGF0YSBmcm9tIERJQS9TV0FUSAp0cmFuc2l0aW9ucy4KClRoZSBmaW5hbCBzdGVwcyBvZiB0aGF0IHByb2Nlc3MgY29tYmluZWQgdGhlIHRyYW5zaXRpb24gaW50ZW5zaXRpZXMgZnJvbSBldmVyeQpzYW1wbGUgaW50byBhIG1ldGFkYXRhIGZyaWxlIChyZXN1bHRzL3RyaWMvSENEX21ldGEudHN2KSwgYW4gaW50ZW5zaXR5IG1hdHJpeAoocmVzdWx0cy90cmljL0hDRF9vdXRtYXRyaXgudHN2KSwgYW5kIGEgZmVhdHVyZSBhbGlnbmVkIG91dHB1dCBtYXRyaXgKKHJlc3VsdHMvdHJpYy9hbGlnbmVkX2NvbWV0X0hDRC50c3YpLgoKTXkgcmVhZGluZyBvZiB0aGUgU1dBVEgyc3RhdHMgYW5kIE1Tc3RhdHMgc291cmNlIGNvZGUgc3VnZ2VzdHMgdG8gbWUgdGhhdCB0aGUKbG9nMihpbnRlbnNpdGllcykgb2YgdGhlIGZlYXR1cmUgYWxpZ25lZCBkYXRhIGFyZSBvdXIgZmluYWwgcHJveHkgZm9yIHByb3RlaW4KYWJ1bmRhbmNlLiAgQXQgZmlyc3QgZ2xhbmNlLCB0aGlzIHN1Z2dlc3RzIHRvIG1lIHRoYXQgdGhlc2UgZGF0YSBtaWdodCBmb2xsb3cgYQpkaXN0cmlidXRpb24gc2ltaWxhciB0byBSTkFTZXEgZGF0YSAobmVnYXRpdmUgYmlub21pYWwsIGJ1dCBwZXJoYXBzIHdpdGggYQpiaWdnZXIgdGFpbD8pLiAgSW4gYWRkaXRpb24sIGJ5IHRoZSB0aW1lIHdlIHVzZSB0cmljIG9uIHRoZSBkYXRhLCB3ZSBoYXZlIGEKY291bnQgbWF0cml4IGFuZCBzYW1wbGUgYW5ub3RhdGlvbiBkYXRhIGZyYW1lcyB3aGljaCBsb29rIHJlbWFya2FibHkgc2ltaWxhciB0bwp0aG9zZSB1c2VkIGluIGEgUk5BU2VxIGV4cHJlc3Npb25zZXQuICBJbmRlZWQsIGJ5IHRoZSBlbmQgb2YgdGhlIE1Tc3RhdHMKcHJvY2Vzc2luZywgaXQgY3JlYXRlcyBhIE1TblNldCBjbGFzcyBvZiBpdHMgb3duIHdoaWNoIHVzZXMgZkRhdGEvZXhwcnMvcERhdGEuCgpGb3IgdGhlIGN1cmlvdXMsIG15IHJlYXNvbmluZyBmb3Igc2F5aW5nIHRoYXQgdGhlIGxvZyBpbnRlbnNpdGllcyBhcmUgb3VyIHByb3h5CmZvciBhYnVuZGFuY2UgY29tZXMgZnJvbSBNU3N0YXRzL1IvRGF0YVByb2Nlc3MuUiBpbiBhIGNsYXVzZSB3aGljaCBsb29rcyBsaWtlOgoKYGBge3Igc25pcHBldCwgZXZhbD1GQUxTRX0KaWYgKGxvZ1RyYW5zID09IDIpIHsKICB3b3JrW1siQUJVTkRBTkNFIl1dIDwtIGxvZzIod29ya1tbIkFCVU5EQU5DRSJdXSkKfSBlbHNlIGlmIChsb2dUcmFucyA9PSAxMCkgewogIHdvcmtbWyJBQlVOREFOQ0UiXV0gPC0gbG9nMTAod29ya1tbIkFCVU5EQU5DRSJdXSkKfSBlbHNlIHsKICAjIyBBYm92ZSB0aGVyZSB3YXMgYSBjaGVjayBmb3Igb25seSBsb2cgMiBhbmQgMTAsIGJ1dCB3ZSBjYW4gZG8gZSBpZiB3ZSB3YW50LgogICMjIEkgbWlnaHQgZ28gYmFjayB1cCB0aGVyZSBhbmQgcmVtb3ZlIHRoYXQgY2hlY2suIExvbmcgbGl2ZSBlISAyLjcxODI4MiBydWxlcyEKICB3b3JrW1siQUJVTkRBTkNFIl1dIDwtIGxvZyh3b3JrW1siQUJVTkRBTkNFIl1dKSAvIGxvZyhsb2dUcmFucykKfQpgYGAKCihOb3RlOiBJIGFkZGVkIHRoZSBuYXR1cmFsIGxvZyB0byB0aGUgc2V0IG9mIGNvbmRpdGlvbnMsIGJ1dCBvdGhlcndpc2UgdGhlIGxvZ2ljCmlzIHVuY2hhbmdlZC4pCgpXaXRoIHRoYXQgaW4gbWluZCwgSSB3YW50IHRvIHVzZSBzb21lIHRvb2xzIHdpdGggd2hpY2ggSSBhbSBmYW1pbGlhciBpbiBvcmRlciB0bwp0cnkgdG8gdW5kZXJzdGFuZCB0aGVzZSBkYXRhLiAgVGhlcmVmb3JlIEkgd2lsbCBmaXJzdCBhdHRlbXB0IHRvIGNvZXJjZSBteSB0cmljCmFsaWduZWQgZGF0YSBhbmQgYW5ub3RhdGlvbnMgaW50byBhICdub3JtYWwnIGV4cHJlc3Npb25zZXQuICBUaGVuIEkgd2FudCB0byBkbwpzb21lIGRpYWdub3N0aWMgcGxvdHMgd2hpY2gsIGlmIEkgYW0gd3JvbmcgYW5kIHRoZXNlIGRpc3RyaWJ1dGlvbnMgYXJlIG5vdCBhcwpleHBlY3RlZCwgd2lsbCBiZSBjb25jZXB0dWFsbHkgaW5jb3JyZWN0IChJIGRvbid0IHlldCB0aGluayBJIGFtIHdyb25nKS4KCiMjIFNhbXBsZSBhbm5vdGF0aW9uIHZpYSBTV0FUSDJzdGF0cwoKSSBhbSB1c2luZyB0aGUgU1dBVEgyc3RhdHMgdmlnbmV0dGUgYXMgbXkgcHJpbWFyeSBzb3VyY2Ugb2YgaW5mb3JtYXRpb24uICBUaHVzIEkKc2VlIHRoYXQgaXQgdXNlcyB0aGUKT3BlblNXQVRIX1NNM19Hb2xkU3RhbmRhcmRBdXRvbWF0ZWRSZXN1bHRzX2h1bWFuX3BlYWtncm91cHMudHh0IHdoaWNoIGhhcyBhCmZvcm1hdCBuZWFybHkgaWRlbnRpY2FsIHRvIG15IHRyaWMgb3V0cHV0IG1hdHJpeC4gIFRodXMgZm9yIHRoZSBtb21lbnQgSSB3aWxsCmFzc3VtZSB0aGF0IHRoZSBwcm9wZXIgaW5wdXQgZm9yIFNXQVRIMnN0YXRzIGlzICdyZXN1bHRzL3RyaWMvY29tZXRfSENELnRzdicgYW5kCm5vdCB0aGUgbWV0YWRhdGEgbm9yIG91dHB1dCBtYXRyaXguCgpJIGtlZXAgYSBzYW1wbGUgc2hlZXQgb2YgYWxsIHRoZSBESUEgc2FtcGxlcyB1c2VkIGluIHRoaXMgYW5hbHlzaXMgaW4KJ3NhbXBsZV9zaGVldHMvZGlhX3NhbXBsZXMueGxzeCcgIEl0IHNob3VsZCBjb250YWluIGFsbCB0aGUgb3RoZXIgcmVxdWlyZWQgZGF0YQp3aXRoIG9uZSBpbXBvcnRhbnQgY2F2ZWF0LCBJIHJlbW92ZWQgMSBzYW1wbGUgYnkgJ2NvbW1lbnRpbmcnIGl0IChlLmcuIHByZWZpeGluZwppdCB3aXRoICcjIycgLS0gd2hpY2ggaXMgYW4gYWRtaXR0ZWRseSBkdW1iIHRoaW5nIHRvIGRvIGluIGFuIGV4Y2VsIGZpbGUuCgpPbmUgbGFzdCBjYXZlYXQ6IEkgaGFja2VkIHRoZSBTV0FUSDJzdGF0cyBzYW1wbGVfYW5ub3RhdGlvbigpIGZ1bmN0aW9uIHRvIGFkZCBhCmNvdXBsZSBjb2x1bW5zIGluIGFuIGF0dGVtcHQgdG8gbWFrZSBpdCBhIGxpdHRsZSBtb3JlIHJvYnVzdCB3aGVuIGZhY2VkIHdpdGgKc2FtcGxlIHNoZWV0cyB3aXRoIGRpZmZlcmVudGx5IG5hbWVkIGNvbHVtbnMuCgpJbiBhZGRpdGlvbiwgU1dBVEgyc3RhdHMgcHJvdmlkZXMgc29tZSBuaWNlIGZpbHRlcmluZyBhbmQgY29tYmluYXRpb24KZnVuY3Rpb25zIHdoaWNoIHNob3VsZCBiZSBjb25zaWRlcmVkIHdoZW4gZ2VuZXJhdGluZyB2YXJpb3VzIGV4cHJlc3Npb25zZXQgZGF0YQpzdHJ1Y3R1cmVzIGxhdGVyLgoKYGBge3Igc3dhdGgyc3RhdHNfc2FtcGxlX2Fubm90YXRpb25zfQp0cmljX2RhdGEgPC0gcmVhZC5jc3YoInJlc3VsdHMvdHJpY18yMDE4MDUvY29tZXRfSENELnRzdiIsIHNlcD0iXHQiKQoKc2FtcGxlX2Fubm90IDwtIG9wZW54bHN4OjpyZWFkLnhsc3goInNhbXBsZV9zaGVldHMvTXRiX2RpYV9zYW1wbGVzLnhsc3giKQpyb3duYW1lcyhzYW1wbGVfYW5ub3QpIDwtIG1ha2UubmFtZXMoc2FtcGxlX2Fubm90W1sic2FtcGxlaWQiXV0sIHVuaXF1ZT1UUlVFKQojIyBEcm9wIHNhbXBsZXMgc3RhcnRpbmcgd2l0aCBjb21tZW50cwprZWVwX2lkeCA8LSAhIGdyZXBsKHBhdHRlcm49IiMjIiwgeD1yb3duYW1lcyhzYW1wbGVfYW5ub3QpKQpzYW1wbGVfYW5ub3QgPC0gc2FtcGxlX2Fubm90W2tlZXBfaWR4LCBdCmV4cHRfaWR4IDwtIHNhbXBsZV9hbm5vdFtbImV4cHRfaWQiXV0gPT0gIm1heTIwMTgiCmV4cHRfaWR4W2lzLm5hKHNhbXBsZV9hbm5vdFtbImV4cHRfaWQiXV0pXSA8LSBGQUxTRQpzYW1wbGVfYW5ub3QgPC0gc2FtcGxlX2Fubm90W2V4cHRfaWR4LCBdCiMjIFNldCB0aGUgbXpYTUwgY29sdW1uIHRvIG1hdGNoIHRoZSBmaWxlbmFtZSBjb2x1bW4gaW4gdGhlIGRhdGEuCmRldnRvb2xzOjpsb2FkX2FsbCgifi9zY3JhdGNoL2dpdC9TV0FUSDJzdGF0cyIpCiMjIHMycywgbXkgd2l0dHkgd2F5IG9mIHNob3J0ZW5pbmcgU1dBVEgyc3RhdHMuLi4KczJzX2V4cCA8LSBzYW1wbGVfYW5ub3RhdGlvbihkYXRhPXRyaWNfZGF0YSwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICBzYW1wbGVfYW5ub3RhdGlvbj1zYW1wbGVfYW5ub3QsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZnVsbHBlcHRpZGVuYW1lX2NvbHVtbj0iZnVsbHVuaW1vZHBlcHRpZGVuYW1lIikKCiMjIyMjIyMjIyMjIwojIyBJTVBPUlRBTlQgQ0FWRUFUCiMjIyMjIyMjIyMjIwojIyBIRVkgWU9VLCBUUkVZLCBSRUFEIFRISVMgT1IgWU9VIFdJTEwgQkUgUElTU0VEIExBVEVSCiMjIyMjIyMjIyMjIwojIyBJIGFtIGtlZXBpbmcgb25seSB0aG9zZSByb3dzIHdoaWNoIGFyZSBmcm9tIHRoZSBtYXJjaCBydW4uCmRpbShzMnNfZXhwKQojIyBXb3csIHRoYXQgZHJvcHBlZCA0NiUgb2YgdGhlIGRhdGEKYGBgCgpOb3cgSSBoYXZlIGEgY291cGxlIGRhdGEgc3RydWN0dXJlcyB3aGljaCBzaG91bGQgcHJvdmUgdXNlZnVsIGZvciB0aGUgbWV0cmljcwpwcm92aWRlZCBieSBTV0FUSDJzdGF0cywgTVNzdGF0cywgYW5kIG15IG93biBocGdsdG9vbHMuCgojIFNXQVRIMnN0YXRzIGNvbnRpbnVlZAoKTGV0cyByZXR1cm4gdG8gc29tZSBvZiB0aGUgbWV0cmljcyBwcm92aWRlZCBieSBzd2F0aDJzdGF0cy4KCmBgYHtyIHN3YXRoMnN0YXRzX3Byb2Nlc3Npbmd9CiMjIEdldCBjb3JyZWxhdGlvbnMgb24gYSBzYW1wbGUgYnkgc2FtcGxlIGJhc2lzCnBwKGZpbGU9ImltYWdlcy9zd2F0aDJzdGF0c19zYW1wbGVfY29yLnBuZyIpCnNhbXBsZV9jb3IgPC0gcGxvdF9jb3JyZWxhdGlvbl9iZXR3ZWVuX3NhbXBsZXMoczJzX2V4cCwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBDb21wYXJpc29uPXRyYW5zaXRpb25fZ3JvdXBfaWQgfiBydW4sCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZnVuLmFnZ3JlZ2F0ZT1zdW0sCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgY29sdW1uLnZhbHVlcz0iaW50ZW5zaXR5IikKZGV2Lm9mZigpCnNhbXBsZV9jb25kX3JlcF9jb3IgPC0gcGxvdF9jb3JyZWxhdGlvbl9iZXR3ZWVuX3NhbXBsZXMoczJzX2V4cCwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBDb21wYXJpc29uPXRyYW5zaXRpb25fZ3JvdXBfaWQgfgogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgY29uZGl0aW9uICsgYmlvcmVwbGljYXRlICsgcnVuLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGZ1bi5hZ2dyZWdhdGU9c3VtLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGNvbHVtbi52YWx1ZXM9ImludGVuc2l0eSIpCiMjIEkgYW0gYSBsaXR0bGUgY29uY2VybmVkIHRoYXQgdGhlc2UgdmFsdWVzIGRvIG5vdCBzZWVtIHRvIGNoYW5nZSB3aGVuIEkgdG9vawojIyBmaWx0ZXJlZC9ub3JtYWxpemVkIGRhdGEuICBTbyBJIGFtIHJlcnVubmluZyB0aGVtIG1hbnVhbGx5IGZvciBhIG1vbWVudCAtLQojIyBwZXJoYXBzIEkgbWVzc2VkIHNvbWV0aGluZyB1cCB3aGVuIEkgcmV3cm90ZSBwb3J0aW9ucyBvZiB0aGUKIyMgc2FtcGxlX2Fubm90YXRpb24oKSBmdW5jdGlvbiBpbiBTV0FUSDJzdGF0cy4KCiMjIGFoaCBJIHRoaW5rIEkgc2VlIHRoZSBwcm9ibGVtLiAgVGhlIGRlZmF1bHQgdmFsdWUgZm9yIGZ1bi5hZ2dyZWdhdGUgaXMgTlVMTCwKIyMgd2hpY2ggY2F1c2VzIGRjYXN0IHRvIGRlZmF1bHQgdG8gbGVuZ3RoLiAgSSB0aGluayB0aGlzIGlzIG5vdCBsaWtlbHkgdG8gYmUKIyMgdmFsaWQgZm9yIHRoaXMgZGF0YS4gIEkgYW0gbm90IGNlcnRhaW4sIGhvd2V2ZXIsIHdoYXQgaXMgdGhlIGFwcHJvcHJpYXRlCiMjIGZ1bmN0aW9uLiAgSWYgSSBoYWQgdG8gZ3Vlc3MsIEkgd291bGQgZ28gd2l0aCBzdW0oKT8KCmFzc2Vzc19kZWNveV9yYXRlKHMyc19leHApCiMjIFRoaXMgc2VlbXMgYSBiaXQgaGlnaCB0byBtZSwgeWVzbm8/CmZkcl9vdmVyYWxsIDwtIGFzc2Vzc19mZHJfb3ZlcmFsbChzMnNfZXhwLCBvdXRwdXQ9IlJjb25zb2xlIiwgcGxvdD1UUlVFKQoKYnlydW5fZmRyIDwtIGFzc2Vzc19mZHJfYnlydW4oczJzX2V4cCwgRkZUPTAuNywgcGxvdD1UUlVFLCBvdXRwdXQ9IlJjb25zb2xlIikKbXNjb3JlNGFzc2F5ZmRyKHMyc19leHAsIEZGVD0wLjcsIGZkcl90YXJnZXQ9MC4wMikKcHJvdF9zY29yZSA8LSBtc2NvcmU0cHJvdGZkcihzMnNfZXhwLCBGRlQ9MC43LCBmZHJfdGFyZ2V0PTAuMDIpCgptc2NvcmVfZmlsdGVyZWQgPC0gU1dBVEgyc3RhdHM6OmZpbHRlcl9tc2NvcmUoczJzX2V4cCwgcHJvdF9zY29yZSkKZGF0YV9maWx0ZXJlZF9tc2NvcmUgPC0gZmlsdGVyX21zY29yZV9mcmVxb2JzKHMyc19leHAsIDAuMDEsIDAuOCwgcm0uZGVjb3k9RkFMU0UpCmRhdGFfZmlsdGVyZWRfZmRyIDwtIGZpbHRlcl9tc2NvcmVfZmRyKHMyc19leHAsIEZGVD0wLjcsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIG92ZXJhbGxfcHJvdGVpbl9mZHJfdGFyZ2V0PTAuMDMsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIHVwcGVyX292ZXJhbGxfcGVwdGlkZV9mZHJfbGltaXQ9MC4wNSkKb25seV9wcm90ZW90eXBpYyA8LSBmaWx0ZXJfcHJvdGVvdHlwaWNfcGVwdGlkZXMoZGF0YV9maWx0ZXJlZF9mZHIpCmFsbF9maWx0ZXJlZCA8LSBmaWx0ZXJfYWxsX3BlcHRpZGVzKGRhdGFfZmlsdGVyZWRfZmRyKQpvbmx5X3N0cm9uZyA8LSBmaWx0ZXJfb25fbWF4X3BlcHRpZGVzKGRhdGFfZmlsdGVyZWRfZmRyLCA1KQpvbmx5X21pbmltdW0gPC0gZmlsdGVyX29uX21pbl9wZXB0aWRlcyhvbmx5X3N0cm9uZywgMikKCiMjIEkgdGhpbmsgdGhlc2UgbWF0cml4ZXMgYXJlIHByb2JhYmx5IHNtYXJ0ZXIgdG8gdXNlIHRoYW4gdGhlIHJhdyBvdXRtYXRyaXggZnJvbSB0cmljLgojIyBCdXQgSSBhbSBub3QgYSBmYW4gb2YgcmVyd3JpdGluZyB0aGUgc2FtcGxlIGNvbHVtbiBuYW1lcy4KcHJvdGVpbl9tYXRyaXhfYWxsIDwtIHdyaXRlX21hdHJpeF9wcm90ZWlucyhzMnNfZXhwLCB3cml0ZS5jc3Y9VFJVRSwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBmaWxlbmFtZT0ic3dhdGgyc3RhdHNfcHJvdGVpbl9hbGxfMjAxODA1LmNzdiIpCnByb3RlaW5fbWF0cml4X21zY29yZSA8LSB3cml0ZV9tYXRyaXhfcHJvdGVpbnMobXNjb3JlX2ZpbHRlcmVkLCB3cml0ZS5jc3Y9VFJVRSwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBmaWxlbmFtZT0ic3dhdGgyc3RhdHNfcHJvdGVpbl9tYXRyaXhfbXNjb3JlLmNzdiIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgcm0uZGVjb3k9RkFMU0UpCmRpbShwcm90ZWluX21hdHJpeF9tc2NvcmUpCnBlcHRpZGVfbWF0cml4X21zY29yZSA8LSB3cml0ZV9tYXRyaXhfcGVwdGlkZXMobXNjb3JlX2ZpbHRlcmVkLCB3cml0ZS5jc3Y9VFJVRSwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBmaWxlbmFtZT0ic3dhdGgyc3RhdHNfcGVwdGlkZV9tYXRyaXhfbXNjb3JlLmNzdiIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgcm0uZGVjb3k9RkFMU0UpCnByb3RlaW5fbWF0cml4X21pbmltdW0gPC0gd3JpdGVfbWF0cml4X3Byb3RlaW5zKG9ubHlfbWluaW11bSwgd3JpdGUuY3N2PVRSVUUsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGZpbGVuYW1lPSJzd2F0aDJzdGF0c19wcm90ZWluX21hdHJpeF9taW5pbXVtLmNzdiIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIHJtLmRlY295PUZBTFNFKQpkaW0ocHJvdGVpbl9tYXRyaXhfbWluaW11bSkKcGVwdGlkZV9tYXRyaXhfbWluaW11bSA8LSB3cml0ZV9tYXRyaXhfcGVwdGlkZXMob25seV9taW5pbXVtLCB3cml0ZS5jc3Y9VFJVRSwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZmlsZW5hbWU9InN3YXRoMnN0YXRzX3BlcHRpZGVfbWF0cml4X21pbmltdW0uY3N2IiwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgcm0uZGVjb3k9RkFMU0UpCgpTV0FUSDJzdGF0czo6cGxvdF9jb3JyZWxhdGlvbl9iZXR3ZWVuX3NhbXBsZXMoczJzX2V4cCwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGNvbHVtbi52YWx1ZXM9InJ0IiwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGZ1bi5hZ2dyZWdhdGU9c3VtKQojIyBJIGhhdmUgbm8gZWZmaW5nIGNsdWUgd2hhdCB0aGlzIHBsb3QgbWVhbnMuCnZhcmlhdGlvbiA8LSBTV0FUSDJzdGF0czo6cGxvdF92YXJpYXRpb24oczJzX2V4cCwgZnVuLmFnZ3JlZ2F0ZT1zdW0sCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgQ29tcGFyaXNvbj10cmFuc2l0aW9uX2dyb3VwX2lkIH4gQ29uZGl0aW9uKQoKIyMgU29tZXRoaW5nIGluIFNXQVRIMnN0YXRzOjpkaXNhZ2dyZWdhdGUgd2FzIHdyaXR0ZW4gcG9vcmx5IGFuZCBpcyBsb29raW5nIGZvcgojIyBhIHZhcmlhYmxlIG5hbWVkICdjb2xzJwpjb2xzIDwtIGNvbG5hbWVzKG9ubHlfbWluaW11bSkKZGlzYWdncmVnYXRlZCA8LSBTV0FUSDJzdGF0czo6ZGlzYWdncmVnYXRlKHMyc19leHAsIGFsbC5jb2x1bW5zPVRSVUUpCm1zc3RhdHNfaW5wdXQgPC0gU1dBVEgyc3RhdHM6OmNvbnZlcnQ0TVNzdGF0cyhkaXNhZ2dyZWdhdGVkKQoKYWxmcV9pbnB1dCA8LSBzbShTV0FUSDJzdGF0czo6Y29udmVydDRhTEZRKGRpc2FnZ3JlZ2F0ZWQpKQptYXBkaWFfaW5wdXQgPC0gc20oU1dBVEgyc3RhdHM6OmNvbnZlcnQ0bWFwRElBKGRpc2FnZ3JlZ2F0ZWQsIFJUPVRSVUUpKQpgYGAKCiMjIE1Tc3RhdHMKCm1zc3RhdHMub3JnIHNlZW1zIHRvIHByb3ZpZGUgYSBjb21wbGV0ZSBzb2x1dGlvbiBmb3IgcGVyZm9ybWluZyByZWFzb25hYmxlIG1ldHJpY3Mgb2YgdGhpcyBkYXRhLgoKSSBhbSBjdXJyZW50bHkgcmVhZGluZzogaHR0cDovL21zc3RhdHMub3JnL3dwLWNvbnRlbnQvdXBsb2Fkcy8yMDE3LzAxL01Tc3RhdHNfdjMuNy4zX21hbnVhbC5wZGYKCkkgbWFkZSBzb21lIG1vZGVyYXRlbHkgaW50cnVzaXZlIGNoYW5nZXMgdG8gTVNzdGF0cyB0byBtYWtlIGl0IGNsZWFyZXIsIGFzIHdlbGwuCgpgYGB7ciBtc3N0YXRzX3F1YW50fQpkZXZ0b29sczo6bG9hZF9hbGwoIn4vc2NyYXRjaC9naXQvTVNzdGF0cyIpCm1zc3RhdHNfcXVhbnQgPC0gTVNzdGF0czo6ZGF0YVByb2Nlc3MobXNzdGF0c19pbnB1dCkKCm1zc3RhdHNfcGxvdHMgPC0gTVNzdGF0czo6ZGF0YVByb2Nlc3NQbG90cyhtc3N0YXRzX3F1YW50LCB0eXBlPSJRQ1BMT1QiKQoKbXlfbGV2ZWxzIDwtIGxldmVscyhhcy5mYWN0b3IobXNzdGF0c19pbnB1dCRjb25kaXRpb24pKQpteV9sZXZlbHMKCmNvbXBhcmlzb24gPC0gZ2hldHRvX2NvbnRyYXN0X21hdHJpeChjKCJkZWx0YV93aG9sZSIsICJkZWx0YV9jZiIpLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgYygiY29tcF93aG9sZSIsICJjb21wX2NmIikpCmZpcnN0X2NvbXBhcmlzb24gPC0gdChhcy5tYXRyaXgoY29tcGFyaXNvblsxLCBdKSkKcm93bmFtZXMoZmlyc3RfY29tcGFyaXNvbikgPC0gIndob2xlIgpmaXJzdF9tc3N0YXRzX2NvbXBhcmlzb24gPC0gTVNzdGF0czo6Z3JvdXBDb21wYXJpc29uKGNvbnRyYXN0Lm1hdHJpeD1maXJzdF9jb21wYXJpc29uLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGRhdGE9bXNzdGF0c19xdWFudCkKc2Vjb25kX2NvbXBhcmlzb24gPC0gdChhcy5tYXRyaXgoY29tcGFyaXNvblsyLCBdKSkKcm93bmFtZXMoc2Vjb25kX2NvbXBhcmlzb24pIDwtICJjZiIKc2Vjb25kX21zc3RhdHNfY29tcGFyaXNvbiA8LSBNU3N0YXRzOjpncm91cENvbXBhcmlzb24oY29udHJhc3QubWF0cml4PXNlY29uZF9jb21wYXJpc29uLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGRhdGE9bXNzdGF0c19xdWFudCkKYGBgCgojIyMgUC9QRSBwcm90ZWluIFFDIHBsb3RzIGZvciBZYW4KCllhbiBhc2tlZCBmb3IgdGhlIHAvcGUgcHJvdGVpbiBxYyBwbG90cy4gb2suICBJIGNoYW5nZWQgdGhlIGRhdGFQcm9jZXNzUGxvdHMgdG8KcmV0dXJuIHNvbWV0aGluZyB1c2VmdWwsIHNvIHRoYXQgc2hvdWxkIGJlIHBvc3NpYmxlIG5vdy4KCmBgYHtyIHBlfQpwZV9nZW5lcyA8LSByZWFkLnRhYmxlKCJyZWZlcmVuY2UvYW5ub3RhdGVkX3BlX2dlbmVzLnR4dCIpW1sxXV0KCiMjIFVuZm9ydHVuYXRlbHksIHRoZSBuYW1lcyBkaWQgbm90IGdldCBzZXQgaW4gbXkgY2hhbmdlZCB2ZXJzaW9uIG9mIGRhdGFQcm9jZXNzUGxvdHMuLi4KcGxvdGxzdCA8LSBtc3N0YXRzX3Bsb3RzJFFDUExPVAphdmFpbGFibGVfcGxvdHMgPC0gZ3N1YihwYXR0ZXJuPSJeMS8iLCByZXBsYWNlbWVudD0iIiwgeD1sZXZlbHMobXNzdGF0c19xdWFudCRQcm9jZXNzZWREYXRhJFBST1RFSU4pKQpuYW1lcyhwbG90bHN0KSA8LSBhdmFpbGFibGVfcGxvdHMKCnBlX2luX2F2YWlsX2lkeCA8LSBwZV9nZW5lcyAlaW4lIGF2YWlsYWJsZV9wbG90cwpwZV9pbl9hdmFpbCA8LSBwZV9nZW5lc1twZV9pbl9hdmFpbF9pZHhdCnBlX3Bsb3RzIDwtIHBsb3Rsc3RbcGVfaW5fYXZhaWxdCnBkZihmaWxlPSJwZV9xY19wbG90cy5wZGYiKQpmb3IgKHAgaW4gMTpsZW5ndGgocGVfcGxvdHMpKSB7CiAgcGxvdChwZV9wbG90c1tbcF1dKQp9CmRldi5vZmYoKQpgYGAKCiMgQ3JlYXRlIGhwZ2x0b29scyBleHByZXNzaW9uc2V0CgpTaW5jZSBJIGFtIG5vdCBjZXJ0YWluIEkgdW5kZXJzdGFuZCB0aGVzZSBkYXRhLCBJIHdpbGwgdGFrZSB0aGUgaW50ZW5zaXRpZXMgZnJvbQpTV0FUSDJzdGF0cywgbWV0YWRhdGEsIGFuZCBhbm5vdGF0aW9uIGRhdGE7ICBhdHRlbXB0IHRvIGNyZWF0ZSBhICdub3JtYWwnCmV4cHJlc3Npb25zZXQ7IHBva2UgYXQgaXQgdG8gc2VlIHdoYXQgSSBjYW4gbGVhcm4uCgojIyBNYXNzYWdpbmcgdGhlIG1ldGFkYXRhCgpJIHdhbnQgdG8gdXNlIHRoZSBzYW1lIG1ldGFkYXRhIGFzIHdlcmUgdXNlZCBmb3IgTVNzdGF0cy4gIEl0IGhhcyBhIGZldwppbXBvcnRhbnQgZGlmZmVyZW5jZXMgZnJvbSB0aGUgcmVxdWlyZW1lbnRzIG9mIGhwZ2x0b29sczogcHJldHR5IG11Y2ggb25seSB0aGF0CkkgZG8gbm90IGFsbG93IHJvd25hbWVzL3NhbXBsZUlEcyB0byBzdGFydCB3aXRoIGEgbnVtYmVyLgoKYGBge3IgcHJvdGVpbl9wZXB0aWRlX21hdHJpY2VzfQptZXRhZGF0YSA8LSBzYW1wbGVfYW5ub3QKbWV0YWRhdGFbWyJzYW1wbGVpZCJdXSA8LSBwYXN0ZTAoInMiLCBtZXRhZGF0YVtbInNhbXBsZWlkIl1dKQpyb3duYW1lcyhtZXRhZGF0YSkgPC0gbWV0YWRhdGFbWyJzYW1wbGVpZCJdXQpgYGAKCiMjIE1hc3NhZ2luZyB0aGUgZ2VuZSBhbm5vdGF0aW9uIGRhdGEgYW5kIGFkZGluZyB0aGUgbXNzdGF0cyBkYXRhLgoKSSBoYXZlIG15IG93biBhbm5vdGF0aW9uIGRhdGEgZnJvbSB0aGUgZ2ZmIGZpbGUvbWljcm9iZXNvbmxpbmUvd2hhdGV2ZXIsIEkgY2FuCmFkZCB0aGUgTVNzdGF0cyByZXN1bHQgdG8gaXQgc28gdGhhdCBsYXRlciBJIGNhbiBwcmludCB0aGVtIGFsbCB0b2dldGhlci4KCmBgYHtyIG1zc3RhdHNfYW5ub3RhdGlvbnN9CiMjIEhlcmUgaXMgYSBuZWF0IGxpdHRsZSB0aGluZyBJIGNhbiBkbzogIEFkZCB0aGUgTVNzdGF0cyByZXN1bHRzIHRvIG15IGFubm90YXRpb24gZGF0YS4KIyMgVGhlbiB3aGVuIEkgcHJpbnQgb3V0IHRoZSB0YWJsZXMgb2YgdGhlIGxpbW1hL2V0YyByZXN1bHRzLCB0aGV5IE1Tc3RhdHMKIyMgcmVzdWx0cyB3aWxsIGNvbWUgYWxvbmcgZm9yIGZyZWUuCm1zc3RhdHNfdGFibGUgPC0gZmlyc3RfbXNzdGF0c19jb21wYXJpc29uW1siQ29tcGFyaXNvblJlc3VsdCJdXQpyb3duYW1lcyhtc3N0YXRzX3RhYmxlKSA8LSBnc3ViKHBhdHRlcm49Il4xXFwvIiwgcmVwbGFjZW1lbnQ9IiIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgeD1tc3N0YXRzX3RhYmxlW1siUHJvdGVpbiJdXSkKbXRiX2Fubm90YXRpb25zX3dpdGhfbXNzdGF0cyA8LSBtZXJnZShtdGJfYW5ub3RhdGlvbnMsIG1zc3RhdHNfdGFibGUsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgYnk9InJvdy5uYW1lcyIsIGFsbC54PVRSVUUpCnJvd25hbWVzKG10Yl9hbm5vdGF0aW9uc193aXRoX21zc3RhdHMpIDwtIG10Yl9hbm5vdGF0aW9uc193aXRoX21zc3RhdHNbWyJSb3cubmFtZXMiXV0KbXRiX2Fubm90YXRpb25zX3dpdGhfbXNzdGF0cyA8LSBtdGJfYW5ub3RhdGlvbnNfd2l0aF9tc3N0YXRzWywgLTFdCmBgYAoKIyMgTWFzc2FnaW5nIHRoZSBpbnRlbnNpdHkgbWF0cml4CgpJIGRvIG5vdCB3YW50IHRoZSBcMSBiZWZvcmUgdGhlIHByb3RlaW4gbmFtZXMsIEkgYWxyZWFkeSBtZXJnZWQgdGhlbSBpbnRvIG9uZQplbnRyeSBwZXIgZ2VuZSB2aXMgU1dBVEgyc3RhdHMuCgpgYGB7ciBwcm90ZWluX21hdHJpeH0KcHJvdF9tdHJ4IDwtIHJlYWQuY3N2KCJzd2F0aDJzdGF0c19wcm90ZWluX2FsbF8yMDE4MDUuY3N2IikKcm93bmFtZXMocHJvdF9tdHJ4KSA8LSBnc3ViKHBhdHRlcm49Il4xXFwvIiwgcmVwbGFjZW1lbnQ9IiIsIHg9cHJvdF9tdHJ4W1sicHJvdGVpbm5hbWUiXV0pCnByb3RfbXRyeCA8LSBwcm90X210cnhbLCAtMV0KIyMgSW1wb3J0YW50IHF1ZXN0aW9uOiBEaWQgU1dBVEgyc3RhdHMgcmVvcmRlciBteSBkYXRhPwpmdW4gPC0gZ3N1YihwYXR0ZXJuPSJeLipfKDIwMTguKiQpIiwgcmVwbGFjZW1lbnQ9IlxcMSIsIHg9Y29sbmFtZXMocHJvdF9tdHJ4KSkKY29sbmFtZXMocHJvdF9tdHJ4KSA8LSBwYXN0ZTAoInMiLCBmdW4pCgpkZWNveV9pZHggPC0gISBncmVwbChwYXR0ZXJuPSJERUNPWSIsIHg9cm93bmFtZXMocHJvdF9tdHJ4KSkKcHJvdF9tdHJ4IDwtIHByb3RfbXRyeFtkZWNveV9pZHgsIF0KCnByb3RfbXRyeF9tb2RpZmllZCA8LSBwcm90X210cngKemVyb19pZHggPC0gcHJvdF9tdHJ4ID09IDAKcHJvdF9tdHJ4X21vZGlmaWVkW3plcm9faWR4XSA8LSAyCmBgYAoKIyMgTWVyZ2UgdGhlIHBpZWNlcwoKTm93IHdlIHNob3VsZCBoYXZlIHN1ZmZpY2llbnQgcGllY2VzIHRvIG1ha2UgYW4gZXhwcmVzc2lvbnNldC4KCmBgYHtyIGV4cHR9CiMjIERyb3AgdGhlIG1ldGFkYXRhIG5vdCBpbiB0aGUgcHJvdGVpbiBtYXRyaXg6CiMjIEFuZCBlbnN1cmUgdGhhdCB0aGV5IGFyZSB0aGUgc2FtZSBvcmRlci4KcmVvcmRlcmVkIDwtIGNvbG5hbWVzKHByb3RfbXRyeCkKbWV0YWRhdGEgPC0gbWV0YWRhdGFbcmVvcmRlcmVkLCBdCgpwcm90ZWluX2V4cHQgPC0gY3JlYXRlX2V4cHQobWV0YWRhdGEsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICBjb3VudF9kYXRhZnJhbWU9cHJvdF9tdHJ4LAogICAgICAgICAgICAgICAgICAgICAgICAgICAgZ2VuZV9pbmZvPW10Yl9hbm5vdGF0aW9uc193aXRoX21zc3RhdHMpCgpgYGAKCmBgYHtyIHByb3RlaW5fbWV0cmljcywgZmlnLnNob3c9J2hpZGUnfQpwcm90ZWluX21ldHJpY3MgPC0gc20oZ3JhcGhfbWV0cmljcyhwcm90ZWluX2V4cHQpKQpwcm90ZWluX25vcm0gPC0gc20obm9ybWFsaXplX2V4cHQocHJvdGVpbl9leHB0LCB0cmFuc2Zvcm09ImxvZzIiLCBjb252ZXJ0PSJjcG0iLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgbm9ybT0icXVhbnQiLCBmaWx0ZXI9VFJVRSkpCnByb3RlaW5fbm9ybV9tZXRyaWNzIDwtIHNtKGdyYXBoX21ldHJpY3MocHJvdGVpbl9ub3JtKSkKYGBgCgpgYGB7ciBwcmludF9tZXRyaWNzfQpwcm90ZWluX21ldHJpY3MkbGlic2l6ZQpwcm90ZWluX25vcm1fbWV0cmljcyRwY2FwbG90CmBgYAoKIyBBdHRlbXB0IHNvbWUgcXVhbnRpZmljYXRpb24gY29tcGFyaXNvbnM/CgpgYGB7ciBkZV90ZXN0aW5nfQpwYWlyd2lzZV9maWx0IDwtIHNtKG5vcm1hbGl6ZV9leHB0KHByb3RlaW5fZXhwdCwgZmlsdGVyPVRSVUUpKQpwYWlyd2lzZV9jb21wIDwtIGFsbF9wYWlyd2lzZShwYWlyd2lzZV9maWx0LCBwYXJhbGxlbD1GQUxTRSwgZm9yY2U9VFJVRSkKCmtlZXBlcnMgPC0gbGlzdCgiZmlsdHJhdGVfdnNfY2VsbHMiID0gYygid3RfY2YiLCAid3Rfd2hvbGUiKSkKcGFpcndpc2VfdGFibGVzIDwtIGNvbWJpbmVfZGVfdGFibGVzKHBhaXJ3aXNlX2NvbXAsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBleGNlbD0iZXhjZWwvdGVzdF9wYWlyd2lzZV9kZV93aXRoX21zc3RhdHMueGxzeCIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBrZWVwZXJzPWtlZXBlcnMpCmRyb3BwZXJzIDwtIGMoInVuZGVmaW5lZCIpCm5hbWVzKGRyb3BwZXJzKSA8LSAibG9nMmZjIgpwYWlyd2lzZV9vbmx5YWxsIDwtIGNvbWJpbmVfZGVfdGFibGVzKHBhaXJ3aXNlX2NvbXAsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZXhjZWw9ImV4Y2VsL3Rlc3RfcGFpcndpc2VfZGVfb25seV9tc3N0YXRzLnhsc3giLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGtlZXBlcnM9a2VlcGVycywKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBleGNsdWRlcz1kcm9wcGVycykKcGFpcndpc2Vfc2lnIDwtIHNtKGV4dHJhY3Rfc2lnbmlmaWNhbnRfZ2VuZXMocGFpcndpc2VfdGFibGVzLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBleGNlbD0iZXhjZWwvdGVzdF9wYWlyd2lzZV9zaWdfd2l0aF9tc3N0YXRzLnhsc3giKSkKCnNvbG9fcHJvdGVpbnMgPC0gZmVhdHVyZXNfaW5fc2luZ2xlX2NvbmRpdGlvbihwcm90ZWluX2V4cHQpCnByb3RlaW5zX29ubHlfY2YgPC0gc29sb19wcm90ZWluc1tbInNvbG9fdGhpcyJdXVtbInd0X2NmIl1dCnByb3RlaW5zX29ubHlfY2YKcHJvdGVpbnNfb25seV93aG9sZSA8LSBzb2xvX3Byb3RlaW5zW1sic29sb190aGlzIl1dW1sid3Rfd2hvbGUiXV0KbGVuZ3RoKHByb3RlaW5zX29ubHlfd2hvbGUpCmBgYAoKYGBge3IgZGVfdGVzdGluZ19tb2RpZmllZH0KcGFpcndpc2VfbW9kaWZpZWRfY29tcCA8LSBhbGxfcGFpcndpc2UocHJvdGVpbl9tb2RpZmllZF9leHB0LCBwYXJhbGxlbD1GQUxTRSwgZm9yY2U9VFJVRSkKCnBhaXJ3aXNlX21vZGlmaWVkX3RhYmxlcyA8LSBjb21iaW5lX2RlX3RhYmxlcyhwYWlyd2lzZV9tb2RpZmllZF9jb21wLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZXhjZWw9ImV4Y2VsL3Rlc3RfcGFpcndpc2VfbW9kaWZpZWRfZGVfd2l0aF9tc3N0YXRzLnhsc3giLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAga2VlcGVycz1rZWVwZXJzKQpkcm9wcGVycyA8LSBjKCJ1bmRlZmluZWQiKQpuYW1lcyhkcm9wcGVycykgPC0gImxvZzJmYyIKcGFpcndpc2VfbW9kaWZpZWRfb25seWFsbCA8LSBjb21iaW5lX2RlX3RhYmxlcyhwYWlyd2lzZV9tb2RpZmllZF9jb21wLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGV4Y2VsPSJleGNlbC90ZXN0X3BhaXJ3aXNlX2RlX29ubHlfbXNzdGF0cy54bHN4IiwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBrZWVwZXJzPWtlZXBlcnMsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZXhjbHVkZXM9ZHJvcHBlcnMpCnBhaXJ3aXNlX21vZGlmaWVkX3NpZyA8LSBzbShleHRyYWN0X3NpZ25pZmljYW50X2dlbmVzKAogIHBhaXJ3aXNlX21vZGlmaWVkX3RhYmxlcywKICBleGNlbD0iZXhjZWwvdGVzdF9wYWlyd2lzZV9tb2RpZmllZF9zaWdfd2l0aF9tc3N0YXRzLnhsc3giKSkKYGBgCgojIyBDb21wYXJlIGhwZ2x0b29scy9NU3N0YXRzCgpDYW4gd2UgY29tcGFyZSBsaW1tYSBhbmQgcmllbmRzIHRvIE1Tc3RhdHM/CgpgYGB7ciBjb21wYXJlX2NvbXBhcmlzb25zfQpocGdsX3RhYmxlIDwtIHBhaXJ3aXNlX3RhYmxlcyRkYXRhW1sxXV0KbXNzdGF0c190YWJsZSA8LSBtc3N0YXRzX2NvbXBhcmlzb24kQ29tcGFyaXNvblJlc3VsdApyb3duYW1lcyhtc3N0YXRzX3RhYmxlKSA8LSBnc3ViKHBhdHRlcm49Il4xLyIsIHJlcGxhY2VtZW50PSIiLCB4PW1zc3RhdHNfdGFibGUkUHJvdGVpbikKCm1lcmdlZF90YWJsZSA8LSBtZXJnZShocGdsX3RhYmxlLCBtc3N0YXRzX3RhYmxlLCBieT0icm93Lm5hbWVzIikKd3JpdGUuY3N2KGZpbGU9ImltYWdlcy9tZXJnZWRfdGFibGUuY3N2IiwgbWVyZ2VkX3RhYmxlKQpjb3IudGVzdChtZXJnZWRfdGFibGUkbGltbWFfbG9nZmMsIG1lcmdlZF90YWJsZSRsb2cyRkMpCmNvci50ZXN0KG1lcmdlZF90YWJsZSRsaW1tYV9sb2dmYywgbWVyZ2VkX3RhYmxlJGxvZzJGQywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KG1lcmdlZF90YWJsZSRkZXNlcV9sb2dmYywgbWVyZ2VkX3RhYmxlJGxvZzJGQykKY29yLnRlc3QobWVyZ2VkX3RhYmxlJGRlc2VxX2xvZ2ZjLCBtZXJnZWRfdGFibGUkbG9nMkZDLCBtZXRob2Q9InNwZWFybWFuIikKY29yLnRlc3QobWVyZ2VkX3RhYmxlJGVkZ2VyX2xvZ2ZjLCBtZXJnZWRfdGFibGUkbG9nMkZDKQpjb3IudGVzdChtZXJnZWRfdGFibGUkZWRnZXJfbG9nZmMsIG1lcmdlZF90YWJsZSRsb2cyRkMsIG1ldGhvZD0ic3BlYXJtYW4iKQoKY29tYmluZWRfdGFibGUgPC0gcGFpcndpc2VfdGFibGVzJGRhdGFbWzFdXQp1bmRlZmluZWRfaWR4IDwtIGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dID09ICJ1bmRlZmluZWQiCmNvbWJpbmVkX3RhYmxlW3VuZGVmaW5lZF9pZHgsICJsb2cyZmMiXSA8LSBOQQpjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSA8LSBhcy5udW1lcmljKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dKQpjb3IudGVzdChjb21iaW5lZF90YWJsZVtbImxpbW1hX2xvZ2ZjIl1dLCBjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSkKY29yLnRlc3QoY29tYmluZWRfdGFibGVbWyJsaW1tYV9sb2dmYyJdXSwgY29tYmluZWRfdGFibGVbWyJsb2cyZmMiXV0sIG1ldGhvZD0ic3BlYXJtYW4iKQoKaGlnaF90b19sb3dfaWR4IDwtIG9yZGVyKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dLCBuYS5sYXN0PVRSVUUsIGRlY3JlYXNpbmc9VFJVRSkKbG93X3RvX2hpZ2hfaWR4IDwtIG9yZGVyKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dLCBuYS5sYXN0PVRSVUUsIGRlY3JlYXNpbmc9RkFMU0UpCnRvcF81MCA8LSBoZWFkKGNvbWJpbmVkX3RhYmxlW2hpZ2hfdG9fbG93X2lkeCwgXSwgbj0xMDApCmJvdHRvbV81MCA8LSBoZWFkKGNvbWJpbmVkX3RhYmxlW2xvd190b19oaWdoX2lkeCwgXSwgbj0xMDApCgpjb3IudGVzdCh0b3BfNTAkbGltbWFfbG9nZmMsIHRvcF81MCRsb2cyZmMpCmNvci50ZXN0KHRvcF81MCRsaW1tYV9sb2dmYywgdG9wXzUwJGxvZzJmYywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KHRvcF81MCRkZXNlcV9sb2dmYywgdG9wXzUwJGxvZzJmYykKY29yLnRlc3QodG9wXzUwJGRlc2VxX2xvZ2ZjLCB0b3BfNTAkbG9nMmZjLCBtZXRob2Q9InNwZWFybWFuIikKY29yLnRlc3QodG9wXzUwJGVkZ2VyX2xvZ2ZjLCB0b3BfNTAkbG9nMmZjKQpjb3IudGVzdCh0b3BfNTAkZWRnZXJfbG9nZmMsIHRvcF81MCRsb2cyZmMsIG1ldGhvZD0ic3BlYXJtYW4iKQoKY29yLnRlc3QoYm90dG9tXzUwJGxpbW1hX2xvZ2ZjLCBib3R0b21fNTAkbG9nMmZjKQpjb3IudGVzdChib3R0b21fNTAkbGltbWFfbG9nZmMsIGJvdHRvbV81MCRsb2cyZmMsIG1ldGhvZD0ic3BlYXJtYW4iKQpjb3IudGVzdChib3R0b21fNTAkZGVzZXFfbG9nZmMsIGJvdHRvbV81MCRsb2cyZmMpCmNvci50ZXN0KGJvdHRvbV81MCRkZXNlcV9sb2dmYywgYm90dG9tXzUwJGxvZzJmYywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KGJvdHRvbV81MCRlZGdlcl9sb2dmYywgYm90dG9tXzUwJGxvZzJmYykKY29yLnRlc3QoYm90dG9tXzUwJGVkZ2VyX2xvZ2ZjLCBib3R0b21fNTAkbG9nMmZjLCBtZXRob2Q9InNwZWFybWFuIikKCnVwX2luX21zc3RhdHMgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dID4gMF0KdXBfaW5fbXNzdGF0cyA8LSB1cF9pbl9tc3N0YXRzWyFpcy5uYSh1cF9pbl9tc3N0YXRzKV0KdXBfaW5fbGltbWEgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibGltbWFfbG9nZmMiXV0gPiAwXQp1cF9pbl9saW1tYSA8LSB1cF9pbl9saW1tYVshaXMubmEodXBfaW5fbGltbWEpXQp1cF9pbl9lZGdlciA8LSByb3duYW1lcyhjb21iaW5lZF90YWJsZSlbY29tYmluZWRfdGFibGVbWyJlZGdlcl9sb2dmYyJdXSA+IDBdCnVwX2luX2VkZ2VyIDwtIHVwX2luX2VkZ2VyWyFpcy5uYSh1cF9pbl9lZGdlcildCnVwX3Zlbm5fc2V0cyA8LSBsaXN0KAogICJtc3N0YXRzIiA9IHVwX2luX21zc3RhdHMsCiAgImxpbW1hIiA9IHVwX2luX2xpbW1hLAogICJlZGdlciIgPSB1cF9pbl9lZGdlcikKdGVzdGluZyA8LSBWZW5uZXJhYmxlOjpWZW5uKFNldHM9dXBfdmVubl9zZXRzLCApCnBwKGZpbGU9Ii90bXAvdXBfdmVubi5wbmciKQpWZW5uZXJhYmxlOjpwbG90KHRlc3RpbmcsIGRvV2VpZ2h0cz1GQUxTRSkKZGV2Lm9mZigpClZlbm5lcmFibGU6OnBsb3QodGVzdGluZywgZG9XZWlnaHRzPUZBTFNFKQoKZG93bl9pbl9tc3N0YXRzIDwtIHJvd25hbWVzKGNvbWJpbmVkX3RhYmxlKVtjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSA8IDBdCmRvd25faW5fbXNzdGF0cyA8LSBkb3duX2luX21zc3RhdHNbIWlzLm5hKGRvd25faW5fbXNzdGF0cyldCmRvd25faW5fbGltbWEgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibGltbWFfbG9nZmMiXV0gPCAwXQpkb3duX2luX2xpbW1hIDwtIGRvd25faW5fbGltbWFbIWlzLm5hKGRvd25faW5fbGltbWEpXQpkb3duX2luX2VkZ2VyIDwtIHJvd25hbWVzKGNvbWJpbmVkX3RhYmxlKVtjb21iaW5lZF90YWJsZVtbImVkZ2VyX2xvZ2ZjIl1dIDwgMF0KZG93bl9pbl9lZGdlciA8LSBkb3duX2luX2VkZ2VyWyFpcy5uYShkb3duX2luX2VkZ2VyKV0KZG93bl92ZW5uX3NldHMgPC0gbGlzdCgKICAibXNzdGF0cyIgPSBkb3duX2luX21zc3RhdHMsCiAgImxpbW1hIiA9IGRvd25faW5fbGltbWEsCiAgImVkZ2VyIiA9IGRvd25faW5fZWRnZXIpCnRlc3RpbmcgPC0gVmVubmVyYWJsZTo6VmVubihTZXRzPWRvd25fdmVubl9zZXRzLCApCnBwKGZpbGU9Ii90bXAvZG93bl92ZW5uLnBuZyIpClZlbm5lcmFibGU6OnBsb3QodGVzdGluZywgZG9XZWlnaHRzPUZBTFNFKQpkZXYub2ZmKCkKYGBgCgojIFJlcGVhdCB3aXRoIHRoZSBtb2RpZmllZCBkYXRhCgpgYGB7ciBjb21wYXJlX2NvbXBhcmlzb25zX21vZGlmaWVkfQpocGdsX3RhYmxlIDwtIHBhaXJ3aXNlX21vZGlmaWVkX3RhYmxlcyRkYXRhW1sxXV0KbXNzdGF0c190YWJsZSA8LSBtc3N0YXRzX21vZGlmaWVkX2NvbXAkQ29tcGFyaXNvblJlc3VsdApyb3duYW1lcyhtc3N0YXRzX3RhYmxlKSA8LSBnc3ViKHBhdHRlcm49Il4xLyIsIHJlcGxhY2VtZW50PSIiLCB4PW1zc3RhdHNfdGFibGVfbW9kaWZpZWQkUHJvdGVpbikKCm1lcmdlZF90YWJsZSA8LSBtZXJnZShocGdsX3RhYmxlLCBtc3N0YXRzX3RhYmxlLCBieT0icm93Lm5hbWVzIikKd3JpdGUuY3N2KGZpbGU9ImltYWdlcy9tZXJnZWRfdGFibGVfbW9kaWZpZWQuY3N2IiwgbWVyZ2VkX3RhYmxlKQpjb3IudGVzdChtZXJnZWRfdGFibGUkbGltbWFfbG9nZmMsIG1lcmdlZF90YWJsZSRsb2cyRkMpCmNvci50ZXN0KG1lcmdlZF90YWJsZSRsaW1tYV9sb2dmYywgbWVyZ2VkX3RhYmxlJGxvZzJGQywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KG1lcmdlZF90YWJsZSRkZXNlcV9sb2dmYywgbWVyZ2VkX3RhYmxlJGxvZzJGQykKY29yLnRlc3QobWVyZ2VkX3RhYmxlJGRlc2VxX2xvZ2ZjLCBtZXJnZWRfdGFibGUkbG9nMkZDLCBtZXRob2Q9InNwZWFybWFuIikKY29yLnRlc3QobWVyZ2VkX3RhYmxlJGVkZ2VyX2xvZ2ZjLCBtZXJnZWRfdGFibGUkbG9nMkZDKQpjb3IudGVzdChtZXJnZWRfdGFibGUkZWRnZXJfbG9nZmMsIG1lcmdlZF90YWJsZSRsb2cyRkMsIG1ldGhvZD0ic3BlYXJtYW4iKQoKY29tYmluZWRfdGFibGUgPC0gcGFpcndpc2VfdGFibGVzJGRhdGFbWzFdXQp1bmRlZmluZWRfaWR4IDwtIGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dID09ICJ1bmRlZmluZWQiCmNvbWJpbmVkX3RhYmxlW3VuZGVmaW5lZF9pZHgsICJsb2cyZmMiXSA8LSBOQQpjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSA8LSBhcy5udW1lcmljKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dKQpjb3IudGVzdChjb21iaW5lZF90YWJsZVtbImxpbW1hX2xvZ2ZjIl1dLCBjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSkKY29yLnRlc3QoY29tYmluZWRfdGFibGVbWyJsaW1tYV9sb2dmYyJdXSwgY29tYmluZWRfdGFibGVbWyJsb2cyZmMiXV0sIG1ldGhvZD0ic3BlYXJtYW4iKQoKaGlnaF90b19sb3dfaWR4IDwtIG9yZGVyKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dLCBuYS5sYXN0PVRSVUUsIGRlY3JlYXNpbmc9VFJVRSkKbG93X3RvX2hpZ2hfaWR4IDwtIG9yZGVyKGNvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dLCBuYS5sYXN0PVRSVUUsIGRlY3JlYXNpbmc9RkFMU0UpCnRvcF81MCA8LSBoZWFkKGNvbWJpbmVkX3RhYmxlW2hpZ2hfdG9fbG93X2lkeCwgXSwgbj0xMDApCmJvdHRvbV81MCA8LSBoZWFkKGNvbWJpbmVkX3RhYmxlW2xvd190b19oaWdoX2lkeCwgXSwgbj0xMDApCgpjb3IudGVzdCh0b3BfNTAkbGltbWFfbG9nZmMsIHRvcF81MCRsb2cyZmMpCmNvci50ZXN0KHRvcF81MCRsaW1tYV9sb2dmYywgdG9wXzUwJGxvZzJmYywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KHRvcF81MCRkZXNlcV9sb2dmYywgdG9wXzUwJGxvZzJmYykKY29yLnRlc3QodG9wXzUwJGRlc2VxX2xvZ2ZjLCB0b3BfNTAkbG9nMmZjLCBtZXRob2Q9InNwZWFybWFuIikKY29yLnRlc3QodG9wXzUwJGVkZ2VyX2xvZ2ZjLCB0b3BfNTAkbG9nMmZjKQpjb3IudGVzdCh0b3BfNTAkZWRnZXJfbG9nZmMsIHRvcF81MCRsb2cyZmMsIG1ldGhvZD0ic3BlYXJtYW4iKQoKY29yLnRlc3QoYm90dG9tXzUwJGxpbW1hX2xvZ2ZjLCBib3R0b21fNTAkbG9nMmZjKQpjb3IudGVzdChib3R0b21fNTAkbGltbWFfbG9nZmMsIGJvdHRvbV81MCRsb2cyZmMsIG1ldGhvZD0ic3BlYXJtYW4iKQpjb3IudGVzdChib3R0b21fNTAkZGVzZXFfbG9nZmMsIGJvdHRvbV81MCRsb2cyZmMpCmNvci50ZXN0KGJvdHRvbV81MCRkZXNlcV9sb2dmYywgYm90dG9tXzUwJGxvZzJmYywgbWV0aG9kPSJzcGVhcm1hbiIpCmNvci50ZXN0KGJvdHRvbV81MCRlZGdlcl9sb2dmYywgYm90dG9tXzUwJGxvZzJmYykKY29yLnRlc3QoYm90dG9tXzUwJGVkZ2VyX2xvZ2ZjLCBib3R0b21fNTAkbG9nMmZjLCBtZXRob2Q9InNwZWFybWFuIikKCnVwX2luX21zc3RhdHMgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibG9nMmZjIl1dID4gMF0KdXBfaW5fbXNzdGF0cyA8LSB1cF9pbl9tc3N0YXRzWyFpcy5uYSh1cF9pbl9tc3N0YXRzKV0KdXBfaW5fbGltbWEgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibGltbWFfbG9nZmMiXV0gPiAwXQp1cF9pbl9saW1tYSA8LSB1cF9pbl9saW1tYVshaXMubmEodXBfaW5fbGltbWEpXQp1cF9pbl9lZGdlciA8LSByb3duYW1lcyhjb21iaW5lZF90YWJsZSlbY29tYmluZWRfdGFibGVbWyJlZGdlcl9sb2dmYyJdXSA+IDBdCnVwX2luX2VkZ2VyIDwtIHVwX2luX2VkZ2VyWyFpcy5uYSh1cF9pbl9lZGdlcildCnVwX3Zlbm5fc2V0cyA8LSBsaXN0KAogICJtc3N0YXRzIiA9IHVwX2luX21zc3RhdHMsCiAgImxpbW1hIiA9IHVwX2luX2xpbW1hLAogICJlZGdlciIgPSB1cF9pbl9lZGdlcikKdGVzdGluZyA8LSBWZW5uZXJhYmxlOjpWZW5uKFNldHM9dXBfdmVubl9zZXRzLCApCnBwKGZpbGU9Ii90bXAvdXBfdmVubi5wbmciKQpWZW5uZXJhYmxlOjpwbG90KHRlc3RpbmcsIGRvV2VpZ2h0cz1GQUxTRSkKZGV2Lm9mZigpClZlbm5lcmFibGU6OnBsb3QodGVzdGluZywgZG9XZWlnaHRzPUZBTFNFKQoKZG93bl9pbl9tc3N0YXRzIDwtIHJvd25hbWVzKGNvbWJpbmVkX3RhYmxlKVtjb21iaW5lZF90YWJsZVtbImxvZzJmYyJdXSA8IDBdCmRvd25faW5fbXNzdGF0cyA8LSBkb3duX2luX21zc3RhdHNbIWlzLm5hKGRvd25faW5fbXNzdGF0cyldCmRvd25faW5fbGltbWEgPC0gcm93bmFtZXMoY29tYmluZWRfdGFibGUpW2NvbWJpbmVkX3RhYmxlW1sibGltbWFfbG9nZmMiXV0gPCAwXQpkb3duX2luX2xpbW1hIDwtIGRvd25faW5fbGltbWFbIWlzLm5hKGRvd25faW5fbGltbWEpXQpkb3duX2luX2VkZ2VyIDwtIHJvd25hbWVzKGNvbWJpbmVkX3RhYmxlKVtjb21iaW5lZF90YWJsZVtbImVkZ2VyX2xvZ2ZjIl1dIDwgMF0KZG93bl9pbl9lZGdlciA8LSBkb3duX2luX2VkZ2VyWyFpcy5uYShkb3duX2luX2VkZ2VyKV0KZG93bl92ZW5uX3NldHMgPC0gbGlzdCgKICAibXNzdGF0cyIgPSBkb3duX2luX21zc3RhdHMsCiAgImxpbW1hIiA9IGRvd25faW5fbGltbWEsCiAgImVkZ2VyIiA9IGRvd25faW5fZWRnZXIpCnRlc3RpbmcgPC0gVmVubmVyYWJsZTo6VmVubihTZXRzPWRvd25fdmVubl9zZXRzLCApCnBwKGZpbGU9Ii90bXAvZG93bl92ZW5uLnBuZyIpClZlbm5lcmFibGU6OnBsb3QodGVzdGluZywgZG9XZWlnaHRzPUZBTFNFKQpkZXYub2ZmKCkKYGBgCgojIEV2ZXJ5dGhpbmcgYmVsb3cgaGVyZSBtaWdodCBnZXQgZHJvcHBlZD8KCkkgdGhpbmsgSSB3ZWRnZWQgYWxsIG9mIHRoZSBmb2xsb3dpbmcgd29yayBpbnRvIHRoYXQgc2hvcnQgYmxvY2sgYWJvdmUuClNvLCBzdG9wIGV2YWx1YXRpbmcgdGhlIGZvbGxvd2luZyBibG9ja3MgYW5kIHNlZSBpZiB0aGF0IGlzIHRydWUuCgojIyMgRXhwcmVzc2lvbnNldCBmcm9tIHRoZSBUUklDIGludGVuc2l0eSBtYXRyaXgKCmBgYHtyIGhwZ2x0b29sc19leHB0LCBldmFsPUZBTFNFfQppbnRlbnNpdHlfbXRyeCA8LSByZWFkLmNzdihmaWxlPSJyZXN1bHRzL3RyaWMvSENEX291dG1hdHJpeC50c3YiLCBzZXA9Ilx0IikKIyMgVGhlIEhDRF9vdXRtYXRyaXggaGFzIGNvbHVtbnMgaW5jbHVkaW5nOiBQZXB0aWRlLCBQcm90ZWluLAojIyBBIHNlcmllcyBvZiBJbnRlbnNpdHlfc2FtcGxlX2lkIGNvbHVtbnMKIyMgQSBzZXJpZXMgb2YgUlRfc2FtcGxlX2lkIGNvbHVtbnMKIyMgQSBzZXJpZXMgb2Ygc2NvcmVfc2FtcGxlX2lkIGNvbHVtbnMKIyMgQW5kIGF0IHRoZSBlbmQ6IFJUX21lYW4sIFJUX3N0ZCwgYW5kIHBnX3B2YWx1ZS4KIyMgU2luY2UgU1dBVEgyc3RhdHMvTVNzdGF0cyB1c2VzIHRoZSBpbnRlbnNpdGllcywgbGV0cyBnZXQgdGhvc2UgY29sdW1ucyBvdXQsCiMjIHN0YW5kYXJkaXplIHRoZSBjb2x1bW4gbmFtZXMgdG8gbWF0Y2ggdGhlIGFubm90YXRpb24gZGF0YSwgYW5kIHVzZSB0aGVtIGZvcgojIyBjcmVhdGluZyBhbiBleHByZXNzaW9uc2V0LgppbnRlbnNpdHlfbXRyeFtbInJvd25hbWVzIl1dIDwtIGludGVuc2l0eV9tdHJ4W1siUHJvdGVpbiJdXQppbnRlbnNpdHlfbXRyeFtbInJvd25hbWVzIl1dIDwtIGdzdWIocGF0dGVybj0iXltbOmRpZ2l0Ol1dK1xcLyIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICByZXBsYWNlbWVudD0iIiwgeD1pbnRlbnNpdHlfbXRyeFtbInJvd25hbWVzIl1dKQojIyBTdGFuZGFyZGl6ZSB0aGUgcm93bmFtZXMsIHRoaXMgbWlnaHQgYmUgYSBiYWQgaWRlYSwgYXMgdGhpcyB3aWxsIGtlZXAKIyMgc2VwYXJhdGUgZXZlcnkgcGVwdGlkZSBmcm9tIGVhY2ggcHJvdGVpbiBhbmQgbm90IGRvIGFueXRoaW5nIHRvCiMjIHN1bS9tZWRpYW4vd2hhdGV2ZXIgdGhlbS4gIEJ1dCBmb3IgdGhlIHB1cnBvc2VzIG9mIHRlc3Rpbmcgb3V0IHRoZSBkYXRhIEkKIyMgdGhpbmsgaXQgaXMgb2suCnJvd25hbWVzKGludGVuc2l0eV9tdHJ4KSA8LSBtYWtlLm5hbWVzKGludGVuc2l0eV9tdHJ4W1sicm93bmFtZXMiXV0sIHVuaXF1ZT1UUlVFKQoKIyMgTm93IGxldHMgZ2V0IHJpZCBvZiB0aGUgZXh0cmFuZW91cyB0ZXh0IGluIHRoZSBjb2x1bW4gbmFtZXMgYW5kIHNpbXBsaWZ5IHRoZW0KIyMgdG8gdGhlIHNhbXBsZSBuYW1lcyBhcyByZWZlcmVuY2VkIGluIHRoZSBzYW1wbGUgc2hlZXQuCmFsbF9jb2x1bW5zIDwtIGNvbG5hbWVzKGludGVuc2l0eV9tdHJ4KQppbnRlbnNlX2NvbHVtbnMgPC0gZ3JlcGwocGF0dGVybj0iSW50ZW5zaXR5IiwgeD1hbGxfY29sdW1ucykKaW50ZW5zaXR5X210cnggPC0gaW50ZW5zaXR5X210cnhbLCBpbnRlbnNlX2NvbHVtbnNdCmFsbF9jb2x1bW5zIDwtIGNvbG5hbWVzKGludGVuc2l0eV9tdHJ4KQpuZXdfY29sdW1ucyA8LSBnc3ViKHBhdHRlcm49IkludGVuc2l0eV8iLCByZXBsYWNlbWVudD0iIiwgeD1hbGxfY29sdW1ucykKbmV3X2NvbHVtbnMgPC0gZ3N1YihwYXR0ZXJuPSJfZGlhXy4qJCIsIHJlcGxhY2VtZW50PSIiLCB4PW5ld19jb2x1bW5zKQpjb2xuYW1lcyhpbnRlbnNpdHlfbXRyeCkgPC0gcGFzdGUwKCJzIiwgbmV3X2NvbHVtbnMpCmludGVuc2l0eV9tdHJ4W2lzLm5hKGludGVuc2l0eV9tdHJ4KV0gPC0gMAoKIyMgTm8gY29sdW1ucyBpbiBhbiBleHByZXNzaW9uIHNldCBhcmUgYWxsb3dlZCB0byBzdGFydCB3aXRoIGEgbnVtYmVyLiAgSSBoYXZlCiMjIHVuc2VkIHByZWZpeGluZyBzYW1wbGVzIHdpdGggJ3MnIGFzIGEgc3RhbmRhcmQgdG8gaGFuZGxlIHRoaXMgcHJvYmxlbS4uLgptZXRhZGF0YSA8LSBzYW1wbGVfYW5ub3QKbWV0YWRhdGEkc2FtcGxlaWQgPC0gcGFzdGUwKCJzIiwgbWV0YWRhdGEkc2FtcGxlaWQpCmNvbG5hbWVzKGludGVuc2l0eV9tdHJ4KSA8LSBnc3ViKHBhdHRlcm49Il92c19IQ0QiLCByZXBsYWNlbWVudD0iIiwgeD1jb2xuYW1lcyhpbnRlbnNpdHlfbXRyeCkpCnJvd25hbWVzKG1ldGFkYXRhKSA8LSBtZXRhZGF0YSRzYW1wbGVpZAojIyBUaGVvcmV0aWNhbGx5IHRoaXMgaXMgbm90IG5lZWRlZCBhbnltb3JlLi4uCmludGVuc2l0eV9tdHJ4IDwtIGludGVuc2l0eV9tdHJ4Wywgcm93bmFtZXMobWV0YWRhdGEpXQojIyBPaywgYXQgdGhpcyBwb2ludCwgd2Ugc2hvdWxkIGhhdmUgYWxsIHRoZSBwaWVjZXMgZm9yIGEgbW9yZSBvciBsZXNzIG5vcm1hbCBleHByZXNzaW9uc2V0LgpkaW0oaW50ZW5zaXR5X210cngpCnRlc3RfZXhwdCA8LSBjcmVhdGVfZXhwdChtZXRhZGF0YT1tZXRhZGF0YSwKICAgICAgICAgICAgICAgICAgICAgICAgIGNvdW50X2RhdGFmcmFtZT1pbnRlbnNpdHlfbXRyeCwKICAgICAgICAgICAgICAgICAgICAgICAgIGdlbmVfaW5mbz1tdGJfYW5ub3RhdGlvbnMpCmBgYAoKIyMjIFBsYXkgd2l0aCB0aGUgaHBnbHRvb2xzIGRlcml2ZWQgZXhwcmVzc2lvbnNldCBvZiBwZXB0aWRlIGludGVuc2l0aWVzCgpMZXRzIHNlZSBpZiBhbnl0aGluZyBtYWtlcyBzZW5zZSBpbiB0aGlzIGludGVuc2l0eSBleHByZXNzaW9uc2V0LgoKYGBge3IgaHBnbHRvb2xzX2V4cHRfZXhhbWluZSwgZmlnLnNob3c9ImhpZGUiLCBldmFsPUZBTFNFfQojIyBGaXJzdCwgbG9nMiBhbmQgbm9ybWFsaXplIHRoZSBkYXRhLgp0ZXN0X25vcm0gPC0gbm9ybWFsaXplX2V4cHQodGVzdF9leHB0LCB0cmFuc2Zvcm09ImxvZzIiLCBjb252ZXJ0PSJjcG0iLCBub3JtPSJxdWFudGlsZSIsIGZpbHRlcj1UUlVFKQp0ZXN0X25vcm1iYXRjaCA8LSBzbShub3JtYWxpemVfZXhwdCh0ZXN0X2V4cHQsIHRyYW5zZm9ybT0ibG9nMiIsIGNvbnZlcnQ9ImNwbSIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIG5vcm09InF1YW50aWxlIiwgZmlsdGVyPVRSVUUsIGJhdGNoPSJsaW1tYSIpKQoKdGVzdF9tZXRyaWNzIDwtIHNtKGdyYXBoX21ldHJpY3ModGVzdF9leHB0KSkKdGVzdF9tZXRyaWNzX25vcm0gPC0gc20oZ3JhcGhfbWV0cmljcyh0ZXN0X25vcm0pKQp0ZXN0X21ldHJpY3Nfbm9ybWJhdGNoIDwtIHNtKGdyYXBoX21ldHJpY3ModGVzdF9ub3JtYmF0Y2gpKQpgYGAKCk5vdyBsZXRzIHNlZSB3aGF0IHRoZSBkYXRhIGxvb2tzIGxpa2UsIGFzc3VtaW5nIEkgZGlkIG5vdCBkbyBhbnl0aGluZyBob3JyaWJsZQp0byBpdC4KCmBgYHtyIGhwZ2x0b29sc19wbG90cywgZXZhbD1GQUxTRX0KdGVzdF9tZXRyaWNzJGxlZ2VuZAp0ZXN0X21ldHJpY3MkbGlic2l6ZSAgIyMgV293IHRoZSBpbnRlbnNpdGllcyBnZXQgcmlkaWN1bG91cywgd2hhdD8KdGVzdF9tZXRyaWNzJG5vbnplcm8KIyMgSW50ZXJlc3RpbmcsIGJ1dCBub3RoaW5nIHdoaWNoIHN1cGVyLWp1bXBzIG91dCBhdCBtZQp0ZXN0X21ldHJpY3MkZGVuc2l0eQojIyBobW0gdmVyeSBpbnRlcmVzdGluZywgdGhlIGdvb2QgbmV3cyBpcyB0aGF0IHRoZXkgYWxsIGhhdmUgYmFzaWNhbGx5IHRoZSBzYW1lCiMjIGRpc3RyaWJ1dGlvbi4gIEkgZGlkIG5vdCBleHBlY3QgdGhlIENGIHNhbXBsZXMgdG8gaGF2ZSBzdWNoIGEgc3Ryb25nZXIKIyMgZGlzdHJpYnV0aW9uIHRob3VnaC4KCnRlc3RfbWV0cmljc19ub3JtJGNvcmhlYXQKIyMgVGhpcyBzdWdnZXN0cyB0byBtZSBhIGxpa2VseSBiYXRjaCBlZmZlY3QKdGVzdF9tZXRyaWNzX25vcm0kZGlzaGVhdAp0ZXN0X21ldHJpY3Mkc21jCnRlc3RfbWV0cmljcyR0c25lcGxvdAojIyBZZWFoIHRoZXJlIGlzIHNvbWUgd29ua3luZXNzIGJldHdlZW4gdGhlIG9sZC9uZXcgc2FtcGxlcy4KCnRlc3RfbWV0cmljc19ub3JtYmF0Y2gkcGNhcGxvdAojIyBXb3csIHRoaXMgaXMgYWZ0ZXIgaW52b2tpbmcgJ3JlbW92ZUJhdGNoRWZmZWN0JyBmcm9tIGxpbW1hLiAgVGhhdCBzdWdnZXN0cwojIyBwcmV0dHkgc3Ryb25nbHkgdG8gbWUgdGhhdCB3ZSBzaG91bGQgcHJvYmFsYnkgbm90IGV4YW1pbmUgdGhlIG5ldyBhbmQgb2xkCiMjIGRhdGEgdG9nZXRoZXIuICBJbiBhZGRpdGlvbiBJIGFtIHRoaW5raW5nIHRoYXQgb25lIHdob2xlLWNlbGwgbHlzYXRlIHNhbXBsZQojIyBtaWdodCBub3QgYmUuCmBgYAoKIyMgUmVtb3ZlIG9sZCBiYXRjaC93ZWlyZG8gc2FtcGxlCgpgYGB7ciByZW1vdmFscywgZmlnLnNob3c9ImhpZGUiLCBldmFsPUZBTFNFfQprZXB0X3Rlc3RpbmcgPC0gc3Vic2V0X2V4cHQodGVzdF9leHB0LAogICAgICAgICAgICAgICAgICAgICAgICAgICAgc3Vic2V0PSJiaW9yZXBsaWNhdGUgPT0gJ21hciciKQojIyBUaGUgbmV3IGJhdGNoIElEczogeCx5LHogYXJlIGFzc29jaWF0ZWQgd2l0aCB0aGUgMyBydW5zIG9mIHRoZXNlIHNhbXBsZXMsIG9uZQojIyB3aGljaCBpcyA4IG0veiwgb25lIHdoaWNoIGlzIDIwIG0veiwgYW5kIG9uZSB3aGljaCBpcyBhIHJlb3JkZXJlZCAyMCBtL3ouCgp0ZXN0X25vcm0gPC0gbm9ybWFsaXplX2V4cHQoa2VwdF90ZXN0aW5nLCB0cmFuc2Zvcm09ImxvZzIiLCBjb252ZXJ0PSJjcG0iLCBub3JtPSJxdWFudGlsZSIsIGZpbHRlcj1UUlVFKQp0ZXN0X25vcm1iYXRjaCA8LSBzbShub3JtYWxpemVfZXhwdChrZXB0X3Rlc3RpbmcsIHRyYW5zZm9ybT0ibG9nMiIsIGNvbnZlcnQ9ImNwbSIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIGZpbHRlcj1UUlVFLCBiYXRjaD0ibGltbWEiKSkKbmV3X21ldHJpY3MgPC0gc20oZ3JhcGhfbWV0cmljcyhrZXB0X3Rlc3RpbmcpKQpuZXdfbWV0cmljc19ub3JtIDwtIHNtKGdyYXBoX21ldHJpY3ModGVzdF9ub3JtKSkKbmV3X21ldHJpY3Nfbm9ybWJhdGNoIDwtIHNtKGdyYXBoX21ldHJpY3ModGVzdF9ub3JtYmF0Y2gpKQpgYGAKCiMjIyBQbG90IG9ubHkgbmV3IGRhdGEKClJlbW92aW5nIHRoZSBKYW51YXJ5IGRhdGEgc2VlbXMgdG8gaGF2ZSBtYWRlIHRoaXMgYSBsb3QgZWFzaWVyIHRvIGxvb2sgYXQuClRoZXJlIG1pZ2h0IGJlIHNvbWUgYmF0Y2h5bmVzcyBhc3NvY2lhdGVkIHdpdGggcmVvcmRlcmluZyB0aGUgc2FtcGxlcywgYnV0IEkgYW0KdGhpbmtpbmcgaXQgaXMgbm90IGh1Z2UuCgoKYGBge3IgbmV3X2RhdGFfcGxvdHMsIGV2YWw9RkFMU0V9CnR0ID0gcGxvdF90b3BuKGtlcHRfdGVzdGluZywgZGlyZWN0PVRSVUUpCm5ld19tZXRyaWNzJGxlZ2VuZApuZXdfbWV0cmljcyRsaWJzaXplCnBwKCJpbWFnZXMva2VwdF9ub3JtX3RvcG4ucG5nIiwgaW1hZ2U9bmV3X21ldHJpY3MkdG9wbnBsb3QpCnBwKCJpbWFnZXMva2VwdF9ub3JtX2hjZF9wY2EucG5nIiwgaW1hZ2U9bmV3X21ldHJpY3Nfbm9ybSRwY2FwbG90KQpuZXdfbWV0cmljc19ub3JtJHRzbmVwbG90CnBwKCJpbWFnZXMva2VwdF9ub3JtX2hjZF9jb3JoZWF0LnBuZyIsIGltYWdlPW5ld19tZXRyaWNzX25vcm0kY29yaGVhdCkKbmV3X21ldHJpY3Nfbm9ybSRkaXNoZWF0Cm5ld19tZXRyaWNzX25vcm1iYXRjaCRwY2FwbG90CnBwKCJpbWFnZXMvbm9ybWJhdGNoX3RzbmUucG5nIiwgaW1hZ2U9bmV3X21ldHJpY3Nfbm9ybWJhdGNoJHRzbmVwbG90KQpgYGAKCiMjIyBIb3cgaXMgdGhlIHZhcmlhbmNlPwoKTGV0cyBzZWUgd2hhdCB2YXJpYW5jZVBhcnRpdGlvbiBoYXMgdG8gc2F5IGFib3V0IHRoaXMgZGF0YS4KCmBgYHtyIHZhcnBhcnQsIGV2YWw9RkFMU0V9Cm5ld192YXJwYXJ0IDwtIHZhcnBhcnQoa2VwdF90ZXN0aW5nLCBmYWN0b3JzPWMoImNvbmRpdGlvbiIsICJiYXRjaCIpKQpwcCgiaW1hZ2VzL3ZhcnBhcnRfcGFydGl0aW9uLnBuZyIsIGltYWdlPW5ld192YXJwYXJ0JHBhcnRpdGlvbl9wbG90KQojIyBUaGF0IGlzIG5vdCB0ZXJyaWJsZS4KCiMjIHRoZSBtb2RpZmllZF9leHB0IHNsb3cgZnJvbSB2YXJwYXJ0KCkgYWRkcyBzb21lIG1ldGFkYXRhIHRvIHRoZSBleHByZXNzaW9uc2V0CiMjIGluY2x1ZGluZyB0aGUgY2FsY3VsYXRlZCAlIHZhcmlhbmNlIGZvciBjb25kaXRpb24vYmF0Y2gvcmVzaWR1YWwgZm9yIGVhY2ggcGVwdGlkZS4Ka2VwdF90ZXN0aW5nIDwtIG5ld192YXJwYXJ0JG1vZGlmaWVkX2V4cHQKYGBgCgojIyBCYWNrIHRvIGhwZ2x0b29scwoKSWYgeW91IHdpbGwgcmVjYWxsLCBpbiB0aGUgb3JpZ2luYWwgYmxvY2sgd2hlcmUgSSByZWFkIHRoZSBkYXRhIGludG8KU1dBVEgyc3RhdHMsIEkgaW52b2tlZCB3cml0ZV9tYXRyaXhfcHJvdGVpbnMoKSBhbmQgd3JpdGVfbWF0cml4X3BlcHRpZGVzKCkgYW5kCndyb3RlIG91dCAyIGNzdiBmaWxlcyAnc3dhdGgyc3RhdHNfcHJvdGVpbl9tYXRyaXguY3N2JyBhbmQKJ19wZXB0aWRlX21hdHJpeC5jc3YnLiAgSWYgbXkgZWFybGllciB3b3JrIGlzIGNvcnJlY3QsIEkgc2hvdWxkIGJlIGFibGUgdG8gdXNlCnRoZSBwcm90ZWluIG1hdHJpeCB0byBnZXQgYSB0cnVlciBzZW5zZSBvZiB0aGUgcmVsYXRpdmUgYWJ1bmRhbmNlcyBiZXR3ZWVuIG15CmV4cGVyaW1lbnRhbCBjb25kaXRpb25zLgoKYGBge3IgYWxmcV9xdWFudCwgZXZhbD1GQUxTRX0KbGlicmFyeShhTEZRKQphbGZxX3Byb2Nlc3MgPC0gUHJvdGVpbkluZmVyZW5jZShhbGZxX2lucHV0LAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBwZXB0aWRlX21ldGhvZD0idG9wIiwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgcGVwdGlkZV90b3B4PTMsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIHBlcHRpZGVfc3RyaWN0bmVzcz0ibG9vc2UiLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBwZXB0aWRlX3N1bW1hcnk9Im1lYW4iLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICB0cmFuc2l0aW9uX3RvcHg9MywKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgdHJhbnNpdGlvbl9zdHJpY3RuZXNzPSJsb29zZSIsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIHRyYW5zaXRpb25fc3VtbWFyeT0ic3VtIiwKICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgZmFzdGE9TkEsCiAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgIG1vZGVsPU5BLAogICAgICAgICAgICAgICAgICAgICAgICAgICAgICAgICBjb21iaW5lX3ByZWN1cnNvcnM9RkFMU0UpCmBgYAoKIyBJbmRleCB2ZXJzaW9uOiBgciB2ZXJgCgojIFRPRE8KCiogMjAxOC0wNC0xMDogIE1ha2Ugc3VyZSBteSBpbnZvY2F0aW9ucyBvZiBTV0FUSDJzdGF0cy9NU3N0YXRzIGFyZSBjb3JyZWN0LgoKYGBge3Igc2F2ZW1lfQppZiAoIWlzVFJVRShnZXQwKCJza2lwX2xvYWQiKSkpIHsKICBtZXNzYWdlKHBhc3RlMCgiVGhpcyBpcyBocGdsdG9vbHMgY29tbWl0OiAiLCBnZXRfZ2l0X2NvbW1pdCgpKSkKICB0aGlzX3NhdmUgPC0gcGFzdGUwKGdzdWIocGF0dGVybj0iXFwuUm1kIiwgcmVwbGFjZT0iIiwgeD1ybWRfZmlsZSksICItdiIsIHZlciwgIi5yZGEueHoiKQogIG1lc3NhZ2UocGFzdGUwKCJTYXZpbmcgdG8gIiwgdGhpc19zYXZlKSkKICB0bXAgPC0gc20oc2F2ZW1lKGZpbGVuYW1lPXRoaXNfc2F2ZSkpCiAgcGFuZGVyOjpwYW5kZXIoc2Vzc2lvbkluZm8oKSkKfQpgYGAK