[Genabel-commits] r1902 - in branches/ProbABEL-pvals/ProbABEL: . checks checks/R-tests checks/inputfiles checks/verified_results doc examples/gtdata src

noreply at r-forge.r-project.org noreply at r-forge.r-project.org
Mon Dec 29 22:43:04 CET 2014


Author: lckarssen
Date: 2014-12-29 22:43:04 +0100 (Mon, 29 Dec 2014)
New Revision: 1902

Added:
   branches/ProbABEL-pvals/ProbABEL/checks/check_pacoxph_nocovar.sh
   branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/README
   branches/ProbABEL-pvals/ProbABEL/src/invsigma.cpp
   branches/ProbABEL-pvals/ProbABEL/src/invsigma.h
   branches/ProbABEL-pvals/ProbABEL/src/mlinfo.cpp
   branches/ProbABEL-pvals/ProbABEL/src/mlinfo.h
Removed:
   branches/ProbABEL-pvals/ProbABEL/src/data.cpp
   branches/ProbABEL-pvals/ProbABEL/src/data.h
Modified:
   branches/ProbABEL-pvals/ProbABEL/checks/Makefile.am
   branches/ProbABEL-pvals/ProbABEL/checks/R-tests/initial_checks.R
   branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_pacox.R
   branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palinear.R
   branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palogist.R
   branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.map
   branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.mldose
   branches/ProbABEL-pvals/ProbABEL/checks/test_mms.sh
   branches/ProbABEL-pvals/ProbABEL/checks/test_qt.sh
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_add.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_base_add.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_ngp2_2df.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_ngp2_add.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_ngp2_domin.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_ngp2_over_domin.out.txt
   branches/ProbABEL-pvals/ProbABEL/checks/verified_results/height_ngp2_recess.out.txt
   branches/ProbABEL-pvals/ProbABEL/configure.ac
   branches/ProbABEL-pvals/ProbABEL/doc/ChangeLog
   branches/ProbABEL-pvals/ProbABEL/doc/Doxyfile.in
   branches/ProbABEL-pvals/ProbABEL/doc/INSTALL
   branches/ProbABEL-pvals/ProbABEL/doc/Makefile.am
   branches/ProbABEL-pvals/ProbABEL/doc/ProbABEL_manual.tex
   branches/ProbABEL-pvals/ProbABEL/doc/pacoxph.1
   branches/ProbABEL-pvals/ProbABEL/doc/palinear.1
   branches/ProbABEL-pvals/ProbABEL/doc/palogist.1
   branches/ProbABEL-pvals/ProbABEL/doc/probabel.1
   branches/ProbABEL-pvals/ProbABEL/examples/gtdata/test.map
   branches/ProbABEL-pvals/ProbABEL/src/Makefile.am
   branches/ProbABEL-pvals/ProbABEL/src/coxph_data.cpp
   branches/ProbABEL-pvals/ProbABEL/src/coxph_data.h
   branches/ProbABEL-pvals/ProbABEL/src/gendata.cpp
   branches/ProbABEL-pvals/ProbABEL/src/main.cpp
   branches/ProbABEL-pvals/ProbABEL/src/main_functions_dump.cpp
   branches/ProbABEL-pvals/ProbABEL/src/main_functions_dump.h
   branches/ProbABEL-pvals/ProbABEL/src/phedata.cpp
   branches/ProbABEL-pvals/ProbABEL/src/reg1.cpp
   branches/ProbABEL-pvals/ProbABEL/src/reg1.h
   branches/ProbABEL-pvals/ProbABEL/src/regdata.cpp
Log:
Merged the changes in ProbABEL trunk into the ProbABEL-pvals branch.

This includes the v0.4.4 fixes in the Cox PH module.

Done using the command:
svn merge -r r1721:1901 ^/pkg/ProbABEL


NOTE: this version compiles, but the checks (still) fail because the p-values haven't been fully incorporated in the checks yet.


Modified: branches/ProbABEL-pvals/ProbABEL/checks/Makefile.am
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/Makefile.am	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/Makefile.am	2014-12-29 21:43:04 UTC (rev 1902)
@@ -49,13 +49,17 @@
 check_SCRIPTS += test_bt.sh
 endif
 if BUILD_pacoxph
-check_SCRIPTS +=  test_cox.sh
+check_SCRIPTS +=  test_cox.sh check_pacoxph_nocovar.sh
 endif
 
 AM_TESTS_ENVIRONMENT= \
 	PA_BINDIR=$(top_builddir)/src
 TESTS = $(check_SCRIPTS)
 
+## The pacoxph nocovar test doesn't run correctly until bug #1266 is
+## fixed.
+XFAIL_TESTS = check_pacoxph_nocovar.sh
+
 EXTRA_DIST = $(verified_results) $(input_files) $(check_SCRIPTS)
 
 
@@ -118,11 +122,13 @@
 mmscore_prob_recess.out.txt mmscore_prob_add.out.txt			\
 mmscore_prob_2df.out.txt mmscore_prob_fv_2df.out.txt
 
-cleanfiles_cox = coxph_dose_add.out.txt coxph_dose_fv_add.out.txt	\
-coxph_prob_fv_over_domin.out.txt coxph_prob_fv_domin.out.txt		\
-coxph_prob_over_domin.out.txt coxph_prob_fv_add.out.txt			\
-coxph_prob_fv_recess.out.txt coxph_prob_domin.out.txt			\
-coxph_prob_recess.out.txt coxph_prob_add.out.txt			\
+cleanfiles_cox = pacoxph_nocovar_add.out.txt			\
+coxph_data.txt							\
+coxph_dose_add.out.txt coxph_dose_fv_add.out.txt		\
+coxph_prob_fv_over_domin.out.txt coxph_prob_fv_domin.out.txt	\
+coxph_prob_over_domin.out.txt coxph_prob_fv_add.out.txt		\
+coxph_prob_fv_recess.out.txt coxph_prob_domin.out.txt		\
+coxph_prob_recess.out.txt coxph_prob_add.out.txt		\
 coxph_prob_2df.out.txt coxph_prob_fv_2df.out.txt
 
 

Modified: branches/ProbABEL-pvals/ProbABEL/checks/R-tests/initial_checks.R
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/R-tests/initial_checks.R	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/R-tests/initial_checks.R	2014-12-29 21:43:04 UTC (rev 1902)
@@ -11,6 +11,13 @@
 ## look for the variables freq and poly.
 rsq.thresh <- 1e-16
 
+## A function that prints text with empty space following it. Used to
+## print what is tested (to be followed with an OK if all is OK).
+prnt <- function(string) {
+    cat(sprintf("%-50s", string))
+}
+
+
 ####
 ## load the data
 ####
@@ -28,7 +35,7 @@
 idNames   <- dose[, 1]
 idNames   <- sub("[0-9]+->", "", idNames)
 dose[, 1] <- idNames
-cat("Dose: check consistency of names\t\t")
+prnt("Dose: check consistency of names")
 stopifnot( all.equal(dose[, 1], pheno[, 1], tol) )
 cat("OK\n")
 
@@ -39,7 +46,7 @@
 idNames   <- prob[, 1]
 idNames   <- sub("[0-9]+->", "", idNames)
 prob[, 1] <- idNames
-cat("Prob: check consistency of names\t\t")
+prnt("Prob: check consistency of names")
 stopifnot( all.equal(prob[, 1], pheno[, 1], tol) )
 cat("OK\n")
 
@@ -50,7 +57,7 @@
         indexHet <- indexHom + 1
         doseFromProb[, i] <- prob[, indexHom] * 2 + prob[, indexHet]
 }
-cat("Check consistency dose <-> prob gtdata\t\t")
+prnt("Check consistency dose <-> prob gtdata")
 stopifnot( all.equal(dose[, 3:ncol(dose)],
                      as.data.frame(doseFromProb)[,3:ncol(doseFromProb)],
                      tol=tol )

Modified: branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_pacox.R
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_pacox.R	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_pacox.R	2014-12-29 21:43:04 UTC (rev 1902)
@@ -25,7 +25,7 @@
 ####
 ## Run ProbABEL to get the output data we want to compare/verify
 ####
-cat("Running ProbABEL...\t\t\t\t")
+prnt("Running ProbABEL...")
 tmp <- system(paste0("bash ", tests.path, "test_cox.sh 2> /dev/null"),
               intern=TRUE)
 cat("OK\n")
@@ -48,7 +48,7 @@
 ####
 attach(pheno)
 
-cat("Comparing R output with ProbABEL output\t\t")
+cat("Comparing R output with ProbABEL output:\n")
 
 source(paste0(srcdir, "run_model_coxph.R"))
 
@@ -57,48 +57,52 @@
 model.fn <- "coxph( Surv(fupt_chd, chd) ~ sex + age + othercov + snp1 )"
 
 ## Additive model, dosages
+prnt(" additive (dosages)")
 snpdose <- "dose[, i]"
 dose.add.R <- run.model(model.fn.0, model.fn, snpdose)
 colnames(dose.add.R) <- colsAdd
 rownames(dose.add.R) <- NULL
 stopifnot( all.equal(dose.add.PA, dose.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
-
 ## Additive model, probabilities
+prnt(" additive (probabilities)")
 snpprob <- "doseFromProb[, i]"
 prob.add.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.add.R) <- colsAdd
 rownames(prob.add.R) <- NULL
 stopifnot( all.equal(prob.add.PA, prob.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
 ## dominant model
+prnt(" dominant")
 snpprob <- "prob[, indexHom] + prob[, indexHet]"
 prob.dom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.dom.R) <- colsDom
 rownames(prob.dom.R) <- NULL
 stopifnot( all.equal(prob.dom.PA, prob.dom.R, tol=tol) )
-cat("dominant ")
+cat("OK\n")
 
 ## recessive model
+prnt(" recessive")
 snpprob <- "prob[, indexHom]"
 prob.rec.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.rec.R) <- colsRec
 rownames(prob.rec.R) <- NULL
 stopifnot( all.equal(prob.rec.PA, prob.rec.R, tol=tol) )
-cat("recessive ")
+cat("OK\n")
 
 ## over-dominant model
+prnt(" overdominant")
 snpprob <- "prob[, indexHet]"
 prob.odom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.odom.R) <- colsOdom
 rownames(prob.odom.R) <- NULL
 stopifnot( all.equal(prob.odom.PA, prob.odom.R, tol=tol) )
-cat("overdominant ")
+cat("OK\n")
 
-
 ## 2df model
+prnt(" 2df")
 model.fn <-
     "coxph( Surv(fupt_chd, chd) ~ sex + age + othercov + snp1 + snp2 )"
 snpd1 <- "prob[, indexHet]"
@@ -107,6 +111,4 @@
 colnames(prob.2df.R) <- cols2df
 rownames(prob.2df.R) <- NULL
 stopifnot( all.equal(prob.2df.PA, prob.2df.R, tol=tol) )
-cat("2df\n")
-
-cat("\t\t\t\t\t\tOK\n")
+cat("OK\n")

Modified: branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palinear.R
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palinear.R	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palinear.R	2014-12-29 21:43:04 UTC (rev 1902)
@@ -14,7 +14,7 @@
 ####
 ## Run ProbABEL to get the output data we want to compare/verify
 ####
-cat("Running ProbABEL...\t\t\t\t")
+prnt("Running ProbABEL...")
 tmp <- system(paste0("bash ", tests.path, "test_qt.sh"),
               intern=TRUE)
 cat("OK\n")
@@ -36,10 +36,14 @@
 ## (SNP 6 in the info file). ProbABEL lists them all as 0.0, R lists
 ## them as:
 prob.dom.PA[6, 2:4] <- c(NaN, NaN, 0.0)
-#for 2df model the last SNP is interchangeable: EIGEN calculates the beta for the other SNP than R. This causes the beta to have the wrong sign. This part of change the position of the snp beta(and swaps sign) and SE if beta and other SE are 0
-if (sum(abs(prob.2df.PA[6, 2:3]))==0){
-prob.2df.PA[6, 2:3] <-c(prob.2df.PA[6, 4]*-1,prob.2df.PA[6, 5])
-prob.2df.PA[6, 4:5] <- c(NA, NA)
+
+## For the 2df model the last SNP is interchangeable: ProbABEL
+## calculates the beta for the other SNP than R. This causes the beta
+## to have the wrong sign. This part changes the position of the SNP
+## beta (and swaps sign) and SE if beta and the other SE are 0.
+if (sum(abs(prob.2df.PA[6, 2:3])) == 0){
+    prob.2df.PA[6, 2:3] <- c(prob.2df.PA[6, 4] * -1, prob.2df.PA[6, 5])
+    prob.2df.PA[6, 4:5] <- c(NA, NA)
 }
 
 ####
@@ -47,7 +51,7 @@
 ####
 attach(pheno)
 
-cat("Comparing R output with ProbABEL output\t\t")
+cat("Comparing R output with ProbABEL output:\n")
 
 source(paste0(srcdir, "run_model_linear.R"))
 
@@ -55,47 +59,53 @@
 model.fn   <- "lm( height ~ sex + age + snp )"
 
 ## Additive model, dosages
+prnt(" additive (dosages)")
 snpdose <- "dose[, i]"
 dose.add.R <- run.model(model.fn.0, model.fn, snpdose)
 colnames(dose.add.R) <- colsAdd
 rownames(dose.add.R) <- NULL
 stopifnot( all.equal(dose.add.PA, dose.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
-
 ## Additive model, probabilities
+prnt(" additive (probabilities)")
 snpprob <- "doseFromProb[, i]"
 prob.add.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.add.R) <- colsAdd
 rownames(prob.add.R) <- NULL
 stopifnot( all.equal(prob.add.PA, prob.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
 ## dominant model
+prnt(" dominant")
 snpprob <- "prob[, indexHom] + prob[, indexHet]"
 prob.dom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.dom.R) <- colsDom
 rownames(prob.dom.R) <- NULL
 stopifnot( all.equal(prob.dom.PA, prob.dom.R, tol=tol) )
-cat("dominant ")
+cat("OK\n")
 
 ## recessive model
+prnt(" recessive")
 snpprob <- "prob[, indexHom]"
 prob.rec.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.rec.R) <- colsRec
 rownames(prob.rec.R) <- NULL
 stopifnot( all.equal(prob.rec.PA, prob.rec.R, tol=tol) )
-cat("recessive ")
+#print("OK", justify="right")
+cat("OK\n")
 
 ## over-dominant model
+prnt(" overdominant")
 snpprob <- "prob[, indexHet]"
 prob.odom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.odom.R) <- colsOdom
 rownames(prob.odom.R) <- NULL
 stopifnot( all.equal(prob.odom.PA, prob.odom.R, tol=tol) )
-cat("overdominant ")
+cat("OK\n")
 
 ## 2df model
+prnt(" 2df")
 prob.2df.R <- data.frame()
 for (i in 3:dim(dose)[2]) {
         indexHom <- 3 + ( i - 3 ) * 2
@@ -127,8 +137,5 @@
 }
 colnames(prob.2df.R) <- cols2df
 rownames(prob.2df.R) <- NULL
-
 stopifnot( all.equal(prob.2df.PA, prob.2df.R, tol=tol) )
-cat("2df\n")
-
-cat("\t\t\t\t\t\tOK\n")
+cat("OK\n")

Modified: branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palogist.R
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palogist.R	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/R-tests/run_models_in_R_palogist.R	2014-12-29 21:43:04 UTC (rev 1902)
@@ -14,7 +14,7 @@
 ####
 ## Run ProbABEL to get the output data we want to compare/verify
 ####
-cat("Running ProbABEL...\t\t\t\t")
+prnt("Running ProbABEL...")
 tmp <- system(paste0("bash ", tests.path, "test_bt.sh"),
               intern=TRUE)
 cat("OK\n")
@@ -41,7 +41,7 @@
 ####
 attach(pheno)
 
-cat("Comparing R output with ProbABEL output\t\t")
+cat("Comparing R output with ProbABEL output\n")
 
 source(paste0(srcdir, "run_model_logist.R"))
 
@@ -50,47 +50,52 @@
 model.fn  <- "glm( chd ~ sex + age + othercov + snp, family=binomial )"
 
 ## Additive model, dosages
+prnt(" additive (dosages)")
 snpdose <- "dose[, i]"
 dose.add.R <- run.model(model.fn.0, model.fn, snpdose)
 colnames(dose.add.R) <- colsAdd
 rownames(dose.add.R) <- NULL
 stopifnot( all.equal(dose.add.PA, dose.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
 ## Additive model, probabilities
+prnt(" additive (probabilities)")
 snpprob <- "doseFromProb[, i]"
 prob.add.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.add.R) <- colsAdd
 rownames(prob.add.R) <- NULL
 stopifnot( all.equal(prob.add.PA, prob.add.R, tol=tol) )
-cat("additive ")
+cat("OK\n")
 
 ## dominant model
+prnt(" dominant")
 snpprob <- "prob[, indexHom] + prob[, indexHet]"
 prob.dom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.dom.R) <- colsDom
 rownames(prob.dom.R) <- NULL
 stopifnot( all.equal(prob.dom.PA, prob.dom.R, tol=tol) )
-cat("dominant ")
+cat("OK\n")
 
 ## recessive model
+prnt(" recessive")
 snpprob <- "prob[, indexHom]"
 prob.rec.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.rec.R) <- colsRec
 rownames(prob.rec.R) <- NULL
 stopifnot( all.equal(prob.rec.PA, prob.rec.R, tol=tol) )
-cat("recessive ")
+cat("OK\n")
 
 ## over-dominant model
+prnt(" overdominant")
 snpprob <- "prob[, indexHet]"
 prob.odom.R <- run.model(model.fn.0, model.fn, snpprob)
 colnames(prob.odom.R) <- colsOdom
 rownames(prob.odom.R) <- NULL
 stopifnot( all.equal(prob.odom.PA, prob.odom.R, tol=tol) )
-cat("overdominant ")
+cat("OK\n")
 
-
 ## 2df model
+prnt(" 2df")
 prob.2df.R <- data.frame()
 for (i in 3:dim(dose)[2]) {
         indexHom <- 3 + ( i - 3 ) * 2
@@ -124,6 +129,4 @@
 colnames(prob.2df.R) <- cols2df
 rownames(prob.2df.R) <- NULL
 stopifnot( all.equal(prob.2df.PA, prob.2df.R, tol=tol) )
-cat("2df\n")
-
-cat("\t\t\t\t\t\tOK\n")
+cat("OK\n")

Copied: branches/ProbABEL-pvals/ProbABEL/checks/check_pacoxph_nocovar.sh (from rev 1901, pkg/ProbABEL/checks/check_pacoxph_nocovar.sh)
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/check_pacoxph_nocovar.sh	                        (rev 0)
+++ branches/ProbABEL-pvals/ProbABEL/checks/check_pacoxph_nocovar.sh	2014-12-29 21:43:04 UTC (rev 1902)
@@ -0,0 +1,46 @@
+#!/bin/bash
+# L.C. Karssen
+# This script is used to test whether the Cox PH regression works
+# correctly when no covariate is present in the phenotype input file.
+# Currently this test fails, see bug #1266.
+
+echo "Testing pacoxph without covariates..."
+
+# Exit with error when one of the steps in the script fails
+set -e
+
+# -------- Set some default paths and file names -------
+if [ -z ${srcdir} ]; then
+    srcdir="."
+fi
+inputdir="${srcdir}/inputfiles/"
+padir="${srcdir}/../src/"
+
+dosefile="$inputdir/test.mldose"
+infofile="$inputdir/test.mlinfo"
+mapfile="$inputdir/test.map"
+orig_phenofile="$inputdir/coxph_data.txt"
+phenofile="coxph_data.txt"
+outfile="pacoxph_nocovar"
+pacoxph="${padir}/pacoxph"
+
+# ------ Prepare the phenotype file be removing the covariate column
+# from the existing phenotype file ------
+awk '{print $1, $2, $3}' $orig_phenofile > $phenofile
+
+
+# ---------- function definitions ----------
+run_test ()
+{
+    ## When bug #1266 is fixed, this function should be expanded to
+    ## include a verification against known-good results.
+    echo "Checking whether Cox PH regression works without covariates..."
+    $pacoxph -p $phenofile -d $dosefile -i $infofile -m $mapfile \
+        -o $outfile
+
+}
+
+
+# ---------- Continuation of the main function ----------
+run_test
+echo "---- Finished check for Cox regression without covariates ----"

Copied: branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/README (from rev 1901, pkg/ProbABEL/checks/inputfiles/README)
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/README	                        (rev 0)
+++ branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/README	2014-12-29 21:43:04 UTC (rev 1902)
@@ -0,0 +1,15 @@
+This README file describes the 'special' properties of the SNPs in the
+test input files, as well as any other relevant information related
+the files in the inputfiles directory.
+
+* The SNPs
+  - SNP 1: Tests multi-letter alleles (indel, e.g. from 1kG) in Al1 (bug
+           #2586).
+  - SNP 2: Tests multi-letter alleles (indel, e.g. from 1kG) in Al2 (bug
+           #2586); Tests NaN in genetic data.
+  - SNP 3:
+  - SNP 4:
+  - SNP 5: Tests low Rsq in info file.
+  - SNP 6: Tests low MAF, only one out of 200 people has a different dosage.
+
+* Other files

Modified: branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.map
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.map	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.map	2014-12-29 21:43:04 UTC (rev 1902)
@@ -1,6 +1,6 @@
 rs	position	0	1
-rs7247199	204938	A	G
-rs8102643	207859	C	T
+rs7247199	204938	A	GAC
+rs8102643	207859	C	TGGT
 rs8102615	211970	A	T
 rs8105536	212033	A	G
 rs2312724	217034	C	T

Modified: branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.mldose
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.mldose	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/inputfiles/test.mldose	2014-12-29 21:43:04 UTC (rev 1902)
@@ -1,200 +1,200 @@
 1->id636728 MLDOSE 0.678 1.622 1.732 1.585 1.867 1.000
-2->id890314 MLDOSE 0.66 1.621 1.737 1.59 1.869 2.000
+2->id890314 MLDOSE 0.660 1.621 1.737 1.590 1.869 2.000
 3->id102874 MLDOSE 0.684 1.623 1.731 1.585 1.866 2.000
-4->id200949 MLDOSE 0.667 NaN 1.728 1.576 1.866 2.000
-5->id336491 MLDOSE 0.66 1.609 1.737 1.577 1.869 2.000
-6->id988766 MLDOSE 0.687 1.622 1.738 1.59 1.868 2.000
-7->id21999 MLDOSE 0.67 1.62 1.735 1.588 1.867 2.000
+4->id200949 MLDOSE 0.667   NaN 1.728 1.576 1.866 2.000
+5->id336491 MLDOSE 0.660 1.609 1.737 1.577 1.869 2.000
+6->id988766 MLDOSE 0.687 1.622 1.738 1.590 1.868 2.000
+7->id21999 MLDOSE 0.670 1.620 1.735 1.588 1.867 2.000
 8->id433893 MLDOSE 0.663 1.615 1.734 1.572 1.869 2.000
 9->id688932 MLDOSE 0.672 1.619 1.729 1.585 1.862 2.000
-10->id394203 MLDOSE 0.666 1.619 1.729 1.58 1.863 2.000
+10->id394203 MLDOSE 0.666 1.619 1.729 1.580 1.863 2.000
 11->id995678 MLDOSE 0.672 1.619 1.733 1.583 1.867 2.000
-12->id694339 MLDOSE 0.666 1.615 1.733 1.59 1.869 2.000
+12->id694339 MLDOSE 0.666 1.615 1.733 1.590 1.869 2.000
 13->id256455 MLDOSE 0.673 1.617 1.737 1.584 1.869 2.000
-14->id14836 MLDOSE 0.672 1.62 1.737 1.582 1.869 2.000
+14->id14836 MLDOSE 0.672 1.620 1.737 1.582 1.869 2.000
 15->id817128 MLDOSE 0.666 1.609 1.735 1.589 1.868 2.000
-16->id803325 MLDOSE 0.678 1.62 1.73 1.591 1.868 2.000
-17->id521287 MLDOSE 0.661 1.618 1.736 1.585 1.87 2.000
+16->id803325 MLDOSE 0.678 1.620 1.730 1.591 1.868 2.000
+17->id521287 MLDOSE 0.661 1.618 1.736 1.585 1.870 2.000
 18->id701472 MLDOSE 0.666 1.621 1.731 1.585 1.867 2.000
 19->id850010 MLDOSE 0.669 1.615 1.736 1.581 1.868 2.000
 20->id268483 MLDOSE 0.669 1.618 1.732 1.582 1.865 2.000
-21->id738781 MLDOSE 0.666 1.611 1.73 1.59 1.862 2.000
-22->id28411 MLDOSE 0.66 1.62 1.735 1.57 1.869 2.000
+21->id738781 MLDOSE 0.666 1.611 1.730 1.590 1.862 2.000
+22->id28411 MLDOSE 0.660 1.620 1.735 1.570 1.869 2.000
 23->id541635 MLDOSE 0.669 1.622 1.725 1.558 1.868 2.000
 24->id751101 MLDOSE 0.669 1.624 1.738 1.589 1.869 2.000
 25->id826300 MLDOSE 0.666 1.605 1.736 1.586 1.869 2.000
 26->id884387 MLDOSE 0.661 1.604 1.734 1.587 1.868 2.000
 27->id492414 MLDOSE 0.666 1.619 1.733 1.583 1.866 2.000
 28->id268871 MLDOSE 0.669 1.621 1.731 1.576 1.869 2.000
-29->id627354 MLDOSE 0.666 1.615 1.735 1.59 1.869 2.000
-30->id503932 MLDOSE 0.66 1.62 1.735 1.586 1.867 2.000
+29->id627354 MLDOSE 0.666 1.615 1.735 1.590 1.869 2.000
+30->id503932 MLDOSE 0.660 1.620 1.735 1.586 1.867 2.000
 31->id163442 MLDOSE 0.675 1.621 1.737 1.586 1.869 2.000
-32->id317797 MLDOSE 0.654 1.625 1.739 1.57 1.87 2.000
+32->id317797 MLDOSE 0.654 1.625 1.739 1.570 1.870 2.000
 33->id687857 MLDOSE 0.667 1.621 1.734 1.586 1.869 2.000
-34->id871570 MLDOSE 0.666 1.61 1.731 1.576 1.864 2.000
+34->id871570 MLDOSE 0.666 1.610 1.731 1.576 1.864 2.000
 35->id724067 MLDOSE 0.666 1.619 1.736 1.583 1.868 2.000
 36->id874076 MLDOSE 0.676 1.617 1.738 1.585 1.869 2.000
-37->id927863 MLDOSE 0.67 1.62 1.734 1.586 1.865 2.000
-38->id369805 MLDOSE 0.663 1.616 1.73 1.583 1.867 2.000
+37->id927863 MLDOSE 0.670 1.620 1.734 1.586 1.865 2.000
+38->id369805 MLDOSE 0.663 1.616 1.730 1.583 1.867 2.000
 39->id668376 MLDOSE 0.675 1.617 1.736 1.582 1.869 2.000
-40->id717362 MLDOSE 0.66 1.62 1.736 1.59 1.869 2.000
+40->id717362 MLDOSE 0.660 1.620 1.736 1.590 1.869 2.000
 41->id665504 MLDOSE 0.669 1.618 1.732 1.578 1.867 2.000
 42->id336637 MLDOSE 0.661 1.618 1.734 1.576 1.865 2.000
 43->id60633 MLDOSE 0.669 1.619 1.731 1.579 1.866 2.000
 44->id848600 MLDOSE 0.664 1.615 1.737 1.576 1.869 2.000
 45->id169514 MLDOSE 0.664 1.615 1.737 1.583 1.869 2.000
 46->id690732 MLDOSE 0.663 1.619 1.737 1.586 1.868 2.000
-47->id684760 MLDOSE 0.667 1.62 1.734 1.578 1.866 2.000
-48->id553502 MLDOSE 0.672 1.608 1.732 1.59 1.869 2.000
+47->id684760 MLDOSE 0.667 1.620 1.734 1.578 1.866 2.000
+48->id553502 MLDOSE 0.672 1.608 1.732 1.590 1.869 2.000
 49->id214917 MLDOSE 0.669 1.618 1.727 1.588 1.865 2.000
 50->id849169 MLDOSE 0.664 1.624 1.733 1.588 1.867 2.000
 51->id941921 MLDOSE 0.667 1.619 1.731 1.588 1.862 2.000
-52->id784646 MLDOSE 0.663 1.603 1.739 1.584 1.87 2.000
+52->id784646 MLDOSE 0.663 1.603 1.739 1.584 1.870 2.000
 53->id520954 MLDOSE 0.664 1.619 1.732 1.581 1.864 2.000
-54->id996355 MLDOSE 0.66 1.605 1.736 1.586 1.865 2.000
+54->id996355 MLDOSE 0.660 1.605 1.736 1.586 1.865 2.000
 55->id96730 MLDOSE 0.664 1.619 1.736 1.573 1.868 2.000
 56->id673442 MLDOSE 0.666 1.609 1.735 1.575 1.867 2.000
 57->id68305 MLDOSE 0.672 1.618 1.735 1.585 1.866 2.000
 58->id653025 MLDOSE 0.678 1.617 1.738 1.585 1.868 2.000
-59->id208543 MLDOSE 0.664 1.618 1.734 1.58 1.868 2.000
+59->id208543 MLDOSE 0.664 1.618 1.734 1.580 1.868 2.000
 60->id335725 MLDOSE 0.666 1.616 1.714 1.593 1.845 2.000
 61->id980400 MLDOSE 0.663 1.607 1.733 1.588 1.867 2.000
 62->id869939 MLDOSE 0.667 1.619 1.733 1.588 1.865 2.000
-63->id297563 MLDOSE 0.673 1.614 1.72 1.585 1.866 2.000
-64->id852663 MLDOSE 0.666 1.603 1.729 1.585 1.87 2.000
+63->id297563 MLDOSE 0.673 1.614 1.720 1.585 1.866 2.000
+64->id852663 MLDOSE 0.666 1.603 1.729 1.585 1.870 2.000
 65->id162070 MLDOSE 0.666 1.619 1.728 1.572 1.868 2.000
-66->id272875 MLDOSE 0.66 1.605 1.737 1.584 1.869 2.000
-67->id163787 MLDOSE 0.661 1.616 1.723 1.584 1.87 2.000
+66->id272875 MLDOSE 0.660 1.605 1.737 1.584 1.869 2.000
+67->id163787 MLDOSE 0.661 1.616 1.723 1.584 1.870 2.000
 68->id422204 MLDOSE 0.663 1.615 1.734 1.576 1.867 2.000
-69->id120197 MLDOSE 0.66 1.62 1.731 1.588 1.87 2.000
-70->id33660 MLDOSE 0.658 1.62 1.736 1.571 1.869 2.000
+69->id120197 MLDOSE 0.660 1.620 1.731 1.588 1.870 2.000
+70->id33660 MLDOSE 0.658 1.620 1.736 1.571 1.869 2.000
 71->id803855 MLDOSE 0.669 1.616 1.732 1.586 1.865 2.000
 72->id255048 MLDOSE 0.675 1.616 1.726 1.582 1.866 2.000
-73->id690936 MLDOSE 0.657 1.588 1.738 1.59 1.87 2.000
+73->id690936 MLDOSE 0.657 1.588 1.738 1.590 1.870 2.000
 74->id126807 MLDOSE 0.667 1.612 1.731 1.589 1.864 2.000
-75->id99016 MLDOSE 0.667 1.612 1.734 1.59 1.864 2.000
+75->id99016 MLDOSE 0.667 1.612 1.734 1.590 1.864 2.000
 76->id883847 MLDOSE 0.666 1.611 1.736 1.587 1.869 2.000
-77->id354523 MLDOSE 0.669 1.62 1.734 1.584 1.868 2.000
+77->id354523 MLDOSE 0.669 1.620 1.734 1.584 1.868 2.000
 78->id737255 MLDOSE 0.666 1.623 1.733 1.569 1.867 2.000
-79->id990941 MLDOSE 0.675 1.62 1.734 1.585 1.869 2.000
-80->id25464 MLDOSE 0.673 1.62 1.737 1.579 1.868 2.000
-81->id918375 MLDOSE 0.672 1.621 1.737 1.58 1.869 2.000
+79->id990941 MLDOSE 0.675 1.620 1.734 1.585 1.869 2.000
+80->id25464 MLDOSE 0.673 1.620 1.737 1.579 1.868 2.000
+81->id918375 MLDOSE 0.672 1.621 1.737 1.580 1.869 2.000
 82->id537828 MLDOSE 0.666 1.613 1.729 1.585 1.869 2.000
 83->id682778 MLDOSE 0.658 1.621 1.737 1.573 1.869 2.000
-84->id587547 MLDOSE 0.669 1.62 1.738 1.585 1.868 2.000
-85->id670874 MLDOSE 0.666 1.618 1.734 1.58 1.867 2.000
-86->id444459 MLDOSE 0.66 1.617 1.734 1.577 1.87 2.000
+84->id587547 MLDOSE 0.669 1.620 1.738 1.585 1.868 2.000
+85->id670874 MLDOSE 0.666 1.618 1.734 1.580 1.867 2.000
+86->id444459 MLDOSE 0.660 1.617 1.734 1.577 1.870 2.000
 87->id777456 MLDOSE 0.663 1.615 1.732 1.581 1.865 2.000
 88->id452384 MLDOSE 0.666 1.625 1.738 1.588 1.869 2.000
 89->id826975 MLDOSE 0.669 1.619 1.731 1.582 1.865 2.000
-90->id519567 MLDOSE 0.66 1.621 1.732 1.586 1.869 2.000
+90->id519567 MLDOSE 0.660 1.621 1.732 1.586 1.869 2.000
 91->id84292 MLDOSE 0.663 1.618 1.737 1.582 1.868 2.000
 92->id124432 MLDOSE 0.684 1.621 1.736 1.591 1.867 2.000
 93->id800145 MLDOSE 0.681 1.621 1.737 1.587 1.869 2.000
-94->id153857 MLDOSE 0.661 1.617 1.739 1.585 1.87 2.000
+94->id153857 MLDOSE 0.661 1.617 1.739 1.585 1.870 2.000
 95->id587157 MLDOSE 0.663 1.619 1.736 1.584 1.866 2.000
 96->id506262 MLDOSE 0.664 1.613 1.719 1.592 1.855 2.000
 97->id634462 MLDOSE 0.673 1.623 1.737 1.585 1.869 2.000
 98->id687592 MLDOSE 0.664 1.615 1.726 1.584 1.869 2.000
 99->id955526 MLDOSE 0.663 1.621 1.737 1.566 1.869 2.000
-100->id181850 MLDOSE 0.66 1.603 1.736 1.586 1.869 2.000
+100->id181850 MLDOSE 0.660 1.603 1.736 1.586 1.869 2.000
 101->id159506 MLDOSE 0.667 1.621 1.735 1.585 1.868 2.000
-102->id609051 MLDOSE 0.675 1.618 1.73 1.59 1.86 2.000
-103->id963886 MLDOSE 0.663 1.612 1.739 1.581 1.87 2.000
+102->id609051 MLDOSE 0.675 1.618 1.730 1.590 1.860 2.000
+103->id963886 MLDOSE 0.663 1.612 1.739 1.581 1.870 2.000
 104->id405792 MLDOSE 0.682 1.621 1.737 1.589 1.869 2.000
-105->id494172 MLDOSE 0.66 1.607 1.736 1.58 1.868 2.000
-106->id964637 MLDOSE 0.663 1.616 1.73 1.59 1.861 2.000
-107->id799355 MLDOSE 0.669 1.62 1.735 1.585 1.868 2.000
-108->id157111 MLDOSE 0.658 1.601 1.731 1.588 1.87 2.000
-109->id114524 MLDOSE 0.666 1.603 1.729 1.585 1.87 2.000
-110->id954931 MLDOSE 0.676 1.62 1.733 1.585 1.868 2.000
+105->id494172 MLDOSE 0.660 1.607 1.736 1.580 1.868 2.000
+106->id964637 MLDOSE 0.663 1.616 1.730 1.590 1.861 2.000
+107->id799355 MLDOSE 0.669 1.620 1.735 1.585 1.868 2.000
+108->id157111 MLDOSE 0.658 1.601 1.731 1.588 1.870 2.000
+109->id114524 MLDOSE 0.666 1.603 1.729 1.585 1.870 2.000
+110->id954931 MLDOSE 0.676 1.620 1.733 1.585 1.868 2.000
 111->id827034 MLDOSE 0.664 1.613 1.737 1.579 1.869 2.000
-112->id689645 MLDOSE 0.657 1.611 1.736 1.59 1.868 2.000
+112->id689645 MLDOSE 0.657 1.611 1.736 1.590 1.868 2.000
 113->id281585 MLDOSE 0.673 1.621 1.736 1.584 1.869 2.000
 114->id885624 MLDOSE 0.672 1.619 1.734 1.585 1.869 2.000
-115->id577871 MLDOSE 0.67 1.616 1.731 1.585 1.864 2.000
-116->id238796 MLDOSE 0.667 1.62 1.734 1.585 1.867 2.000
-117->id481035 MLDOSE 0.664 1.62 1.737 1.588 1.867 2.000
-118->id972713 MLDOSE 0.666 1.611 1.73 1.589 1.869 2.000
-119->id905484 MLDOSE 0.66 1.62 1.728 1.572 1.869 2.000
+115->id577871 MLDOSE 0.670 1.616 1.731 1.585 1.864 2.000
+116->id238796 MLDOSE 0.667 1.620 1.734 1.585 1.867 2.000
+117->id481035 MLDOSE 0.664 1.620 1.737 1.588 1.867 2.000
+118->id972713 MLDOSE 0.666 1.611 1.730 1.589 1.869 2.000
+119->id905484 MLDOSE 0.660 1.620 1.728 1.572 1.869 2.000
 120->id713511 MLDOSE 0.664 1.605 1.733 1.585 1.866 2.000
-121->id512328 MLDOSE 0.67 1.616 1.737 1.584 1.869 2.000
-122->id703534 MLDOSE 0.67 1.615 1.731 1.59 1.862 2.000
+121->id512328 MLDOSE 0.670 1.616 1.737 1.584 1.869 2.000
+122->id703534 MLDOSE 0.670 1.615 1.731 1.590 1.862 2.000
 123->id409904 MLDOSE 0.678 1.622 1.734 1.585 1.868 2.000
 124->id577169 MLDOSE 0.669 1.616 1.734 1.582 1.867 2.000
-125->id813971 MLDOSE 0.657 1.606 1.72 1.591 1.85 2.000
-126->id558483 MLDOSE 0.669 1.62 1.737 1.59 1.868 2.000
+125->id813971 MLDOSE 0.657 1.606 1.720 1.591 1.850 2.000
+126->id558483 MLDOSE 0.669 1.620 1.737 1.590 1.868 2.000
 127->id892784 MLDOSE 0.669 1.621 1.733 1.586 1.866 2.000
 128->id611178 MLDOSE 0.666 1.611 1.735 1.582 1.866 2.000
-129->id192732 MLDOSE 0.666 1.618 1.735 1.59 1.868 2.000
-130->id917280 MLDOSE 0.66 1.602 1.736 1.567 1.869 2.000
-131->id435876 MLDOSE 0.678 1.619 1.739 1.586 1.87 2.000
-132->id980722 MLDOSE 0.663 1.62 1.735 1.572 1.869 2.000
+129->id192732 MLDOSE 0.666 1.618 1.735 1.590 1.868 2.000
+130->id917280 MLDOSE 0.660 1.602 1.736 1.567 1.869 2.000
+131->id435876 MLDOSE 0.678 1.619 1.739 1.586 1.870 2.000
+132->id980722 MLDOSE 0.663 1.620 1.735 1.572 1.869 2.000
 133->id308273 MLDOSE 0.661 1.617 1.737 1.582 1.868 2.000
 134->id476685 MLDOSE 0.675 1.618 1.733 1.584 1.867 2.000
 135->id315883 MLDOSE 0.669 1.612 1.736 1.573 1.869 2.000
-136->id935945 MLDOSE 0.663 1.614 1.733 1.58 1.865 2.000
+136->id935945 MLDOSE 0.663 1.614 1.733 1.580 1.865 2.000
 137->id991781 MLDOSE 0.664 1.614 1.731 1.586 1.864 2.000
 138->id65199 MLDOSE 0.661 1.619 1.731 1.575 1.869 2.000
-139->id226233 MLDOSE 0.661 1.618 1.724 1.59 1.854 2.000
-140->id860183 MLDOSE 0.66 1.609 1.734 1.577 1.866 2.000
+139->id226233 MLDOSE 0.661 1.618 1.724 1.590 1.854 2.000
+140->id860183 MLDOSE 0.660 1.609 1.734 1.577 1.866 2.000
 141->id295209 MLDOSE 0.669 1.614 1.735 1.585 1.867 2.000
 142->id544964 MLDOSE 0.669 1.619 1.732 1.582 1.868 2.000
 143->id648663 MLDOSE 0.666 1.617 1.734 1.585 1.868 2.000
 144->id710165 MLDOSE 0.666 1.615 1.728 1.585 1.869 2.000
 145->id392593 MLDOSE 0.666 1.621 1.738 1.569 1.868 2.000
-146->id129945 MLDOSE 0.66 1.62 1.733 1.587 1.869 2.000
+146->id129945 MLDOSE 0.660 1.620 1.733 1.587 1.869 2.000
 147->id382621 MLDOSE 0.684 1.621 1.736 1.591 1.867 2.000
-148->id901440 MLDOSE 0.661 1.615 1.718 1.59 1.852 2.000
-149->id39847 MLDOSE 0.669 1.619 1.729 1.58 1.863 2.000
+148->id901440 MLDOSE 0.661 1.615 1.718 1.590 1.852 2.000
+149->id39847 MLDOSE 0.669 1.619 1.729 1.580 1.863 2.000
 150->id526460 MLDOSE 0.664 1.614 1.731 1.586 1.863 2.000
-151->id477473 MLDOSE 0.672 1.619 1.73 1.589 1.862 2.000
+151->id477473 MLDOSE 0.672 1.619 1.730 1.589 1.862 2.000
 152->id448194 MLDOSE 0.669 1.614 1.737 1.586 1.868 2.000
-153->id904184 MLDOSE 0.67 1.618 1.73 1.577 1.868 2.000
-154->id747852 MLDOSE 0.664 1.615 1.73 1.578 1.869 2.000
+153->id904184 MLDOSE 0.670 1.618 1.730 1.577 1.868 2.000
+154->id747852 MLDOSE 0.664 1.615 1.730 1.578 1.869 2.000
 155->id711012 MLDOSE 0.672 1.605 1.736 1.575 1.868 2.000
 156->id683879 MLDOSE 0.672 1.619 1.734 1.588 1.867 2.000
 157->id789575 MLDOSE 0.658 1.618 1.733 1.591 1.863 2.000
 158->id650729 MLDOSE 0.676 1.615 1.733 1.589 1.867 2.000
-159->id934302 MLDOSE 0.66 1.62 1.733 1.581 1.866 2.000
+159->id934302 MLDOSE 0.660 1.620 1.733 1.581 1.866 2.000
 160->id555013 MLDOSE 0.667 1.622 1.731 1.574 1.865 2.000
-161->id82779 MLDOSE 0.675 1.618 1.73 1.585 1.867 2.000
+161->id82779 MLDOSE 0.675 1.618 1.730 1.585 1.867 2.000
 162->id771444 MLDOSE 0.669 1.616 1.718 1.592 1.856 2.000
-163->id821562 MLDOSE 0.675 1.625 1.739 1.58 1.87 2.000
-164->id292809 MLDOSE 0.66 1.614 1.731 1.58 1.869 2.000
+163->id821562 MLDOSE 0.675 1.625 1.739 1.580 1.870 2.000
+164->id292809 MLDOSE 0.660 1.614 1.731 1.580 1.869 2.000
 165->id645690 MLDOSE 0.684 1.624 1.733 1.586 1.867 2.000
 166->id223901 MLDOSE 0.666 1.615 1.733 1.576 1.868 2.000
 167->id41320 MLDOSE 0.661 1.617 1.732 1.576 1.869 2.000
 168->id96181 MLDOSE 0.684 1.621 1.716 1.593 1.867 2.000
 169->id147900 MLDOSE 0.658 1.603 1.738 1.577 1.868 2.000
-170->id702917 MLDOSE 0.669 1.614 1.731 1.59 1.864 2.000
+170->id702917 MLDOSE 0.669 1.614 1.731 1.590 1.864 2.000
 171->id150640 MLDOSE 0.669 1.621 1.734 1.583 1.868 2.000
-172->id518391 MLDOSE 0.66 1.62 1.736 1.589 1.869 2.000
+172->id518391 MLDOSE 0.660 1.620 1.736 1.589 1.869 2.000
 173->id879076 MLDOSE 0.661 1.613 1.738 1.573 1.868 2.000
-174->id952031 MLDOSE 0.66 1.621 1.734 1.58 1.866 2.000
-175->id10055 MLDOSE 0.67 1.611 1.732 1.589 1.866 2.000
+174->id952031 MLDOSE 0.660 1.621 1.734 1.580 1.866 2.000
+175->id10055 MLDOSE 0.670 1.611 1.732 1.589 1.866 2.000
 176->id727213 MLDOSE 0.664 1.622 1.733 1.583 1.869 2.000
-177->id41961 MLDOSE 0.66 1.62 1.737 1.572 1.867 2.000
+177->id41961 MLDOSE 0.660 1.620 1.737 1.572 1.867 2.000
 178->id257209 MLDOSE 0.673 1.616 1.736 1.588 1.869 2.000
-179->id995361 MLDOSE 0.661 1.62 1.723 1.571 1.868 2.000
+179->id995361 MLDOSE 0.661 1.620 1.723 1.571 1.868 2.000
 180->id957918 MLDOSE 0.663 1.618 1.726 1.581 1.869 2.000
-181->id975370 MLDOSE 0.67 1.614 1.738 1.583 1.87 2.000
+181->id975370 MLDOSE 0.670 1.614 1.738 1.583 1.870 2.000
 182->id889896 MLDOSE 0.679 1.618 1.733 1.589 1.869 2.000
-183->id978164 MLDOSE 0.669 1.62 1.735 1.586 1.868 2.000
-184->id90359 MLDOSE 0.675 1.621 1.737 1.58 1.869 2.000
-185->id307158 MLDOSE 0.675 1.615 1.71 1.591 1.86 2.000
+183->id978164 MLDOSE 0.669 1.620 1.735 1.586 1.868 2.000
+184->id90359 MLDOSE 0.675 1.621 1.737 1.580 1.869 2.000
+185->id307158 MLDOSE 0.675 1.615 1.710 1.591 1.860 2.000
 186->id755940 MLDOSE 0.669 1.618 1.734 1.577 1.869 2.000
 187->id995582 MLDOSE 0.666 1.615 1.724 1.591 1.853 2.000
 188->id363965 MLDOSE 0.663 1.619 1.736 1.574 1.868 2.000
-189->id729124 MLDOSE 0.666 1.611 1.73 1.587 1.86 2.000
-190->id871963 MLDOSE 0.67 1.62 1.737 1.585 1.868 2.000
+189->id729124 MLDOSE 0.666 1.611 1.730 1.587 1.860 2.000
+190->id871963 MLDOSE 0.670 1.620 1.737 1.585 1.868 2.000
 191->id475172 MLDOSE 0.663 1.621 1.737 1.579 1.869 2.000
 192->id804699 MLDOSE 0.663 1.619 1.731 1.581 1.868 2.000
-193->id625843 MLDOSE 0.667 1.622 1.738 1.583 1.87 2.000
+193->id625843 MLDOSE 0.667 1.622 1.738 1.583 1.870 2.000
 194->id595713 MLDOSE 0.657 1.599 1.736 1.588 1.869 2.000
 195->id462604 MLDOSE 0.663 1.616 1.731 1.584 1.867 2.000
 196->id106141 MLDOSE 0.672 1.612 1.732 1.589 1.864 2.000
 197->id689349 MLDOSE 0.666 1.609 1.738 1.583 1.869 2.000
-198->id639003 MLDOSE 0.672 1.618 1.728 1.58 1.863 2.000
-199->id393896 MLDOSE 0.663 1.617 1.73 1.579 1.868 2.000
-200->id450307 MLDOSE 0.663 1.622 1.739 1.588 1.87 2.000
+198->id639003 MLDOSE 0.672 1.618 1.728 1.580 1.863 2.000
+199->id393896 MLDOSE 0.663 1.617 1.730 1.579 1.868 2.000
+200->id450307 MLDOSE 0.663 1.622 1.739 1.588 1.870 2.000

Modified: branches/ProbABEL-pvals/ProbABEL/checks/test_mms.sh
===================================================================
--- branches/ProbABEL-pvals/ProbABEL/checks/test_mms.sh	2014-12-29 14:01:35 UTC (rev 1901)
+++ branches/ProbABEL-pvals/ProbABEL/checks/test_mms.sh	2014-12-29 21:43:04 UTC (rev 1902)
@@ -1,6 +1,7 @@
 #!/bin/bash
 # This script runs checks on ProbABEL's palinear module for
 # quantitative traits combined with the mmscore option.
+
 echo "Analysis using MMScore..."
 
 scriptdir=$(dirname $0)
@@ -26,6 +27,7 @@
     exec 3>&1
 fi
 
+echo "base analysis"
 $palinear \
     -p ${inputdir}/mmscore_pheno.PHE \
     -i ${inputdir}/mmscore_gen.mlinfo \
@@ -34,7 +36,6 @@
     -o mmscore_dose \
     --mmscore ${inputdir}/mmscore_InvSigma_aj.sex.age.dat \
     >& 3
-
[TRUNCATED]

To get the complete diff run:
    svnlook diff /svnroot/genabel -r 1902


More information about the Genabel-commits mailing list