Upgrade history

 

2022-07-25 (data files updated)

  1. -vConvertTest: add --factor.

  2. -vQC: Summary file replaced HetSing,HomSing with HetCode,HomCode.

  3. -slurm.all_steps: change TiTv_Cut=2.0 from 2.5.

  4. -slurm.all_steps: SPLIT="--ad" by default. This is necessary for correct --filt-minorVAF filtering.

  5. -slurm.all_steps: add Sequencing Platform File SPF. Conduct more stringent QC if samples were sequenced by different platforms.

  6. -vAAA,vAAA2: default --trend=yes. Good for --my-R (define carrier as gene!=0) and HR/OR (normally per allele).

  7. -data: af_g31nc.gz add faf95_popmax AF_popmax

2022-03-02 (data files updated)

  1. -vSEG,vSEG2,pedpro: allow >1 proband per pedigree. This is useful after merging pedigrees recruited from multiple centers.

  2. -vSVA: can read Sentieon format.

  3. -vAAA,vAAA2: --logistic/--linear with --cat-var will do Firth's regression in each population and then do a meta analysis to combine results.

  4. -vSPLIT: also split AD in genotype and AQ in INFO.

  5. -vAnnGene: add --fix to solve strand problems and correct wrong REF.

  6. -data: add 1000 Genomes data for improved population structure and substructure inference.

  7. -slurm.all_steps: output file xxx.results_detail.gz contains sample ID, affection status, sex, and the original genotype in VCF.

  8. -slurm.all_steps: does PCA within each ancestry separately and writes $OUT.sample_spc.

  9. -slurm.all_steps: does ClinVar annotation for exploratory research and clinically actionable variant identification separately.

  10. -Some options changed

  11. -    vQC: --filt-AD changed to --filt-VAF. add --filt-max-VAF and --min-het-for-VAF.

  12. -    vAAA,vAAA2: --show-if changed to --show-sf. Add --sf-panel --rec-panel.

  13. -    vAAA,vAAA2: --one-sided=false by default.

  14. -    vAAA,vAAA2: default --trend=no. This makes gene-set analysis robust to linkage disequilibrium even when genotypes are not phased.

  15. -    all programs: add --filt-minorVAF --filt-altVAF.

  16. -    all programs: options accept -= when reading a set of arguments.

  17. -    vGrp: --collapse changed to --observed.

  18. -

2021-03-18

  1. -vConvertPed: read a proband column if it exist.

  2. -vAnnGene: add --as-splice and --as-trnslt. Default --as-splice=SpliceAltH.NL.

  3. -vAnnGene: default --sah-lof=no because of its predictive nature.

  4. -vAnnGene: add Blosum62, Grantham, Exon, LastExon, AAposition fields to INFO.

  5. -slurm.all_steps: check whether input file name and par.txt has the word “error”.

  6. -vAAA vAAA2: add --all-filtered to show all filtered variants in incidental finding reports.

  7. -vAAA vAAA2: add --prs --prr to calculate polygenic risk score.

  8. -vDEL: in addition to adding Included_MaxAF_in_BayesDel, also rename BayesDel_nsfp33a_noAF to BayesDel_nsfp33a_addAF after adding AF.

2021-02-15 (data files updated)

  1. -data: add gbags.hbop and gbags.cancer. They can be used as $GBA in slurm.all_steps and slurm.annotate.

  2. -data: add eQTL (obtained from eQTL-catalog) and pQTL (obtained from 6 publications on plasma pQTL).

  3. -data: add kg.aim.* which are genotypes of ancestry informative markers (AIMs) obtained from the 1000 Genomes Project in PLINK format.

  4. -slurm.all_steps: add KEEP_AIM. If KEEP_AIM=kg.aim, the script will use the provided AIMs to infer race (AFR, AMR, EAS, EUR, SAS).

  5. -slurm.all_steps: supports EPACTS. See parameter_section_2/2 of the script.

  6. -slurm.annotate: save outputs to a folder and then compress the folder into a file.

  7. -slurm.annotate: now create output file sorted and indexed by gene symbol. Set VAG=”--sort-bp” to turn off this feature.

  8. -slurm.annotate and slurm.all_steps: if PVN=no, skip running PROVEAN.

  9. -vAnnGene: for intergenic variants, gene is Intergenic_CHR_POS, not NA.

  10. -VQC: sex checking is based on race-specific allele frequencies; otherwise, use ancestry uninformative markers only.

  11. -doc: add a file do.annotate.sh

2020-08-15

  1. -vAAA vAAA2: --linear does Firth's penalized linear regression rather than linear regression.

  2. -vAAA vAAA2: --my-R uses "OUTCOME_VARIABLE" to represent outcome variable and "+COVARIATE_NAMES" for covariates.

  3. -vAnnGene: removed a bug that lead to program ends when calculating MaxEntScan near N.

2020-08-10

  1. -vAnnGene: Use MaxEntScan to predict de novo splicing gain.

  2. -vAnnGene: add options --sah-nl, --sam-nl, --sah-dg, --sam-dg, --sah-lof, --sam-lof. All default to “yes” except --sah-lof and --sam-lof.

  3. -vAnnGene: add option --cat-par, default to Promoter,Enhancer.

  4. -vAnnGene: --etg defaults to @GDB_PETModule_human,@GDB_JEME_EL; remove @GDB_RED,@GDB_JEME_FL,@GDB_FOCS_E,@GDB_FOCS_P.

  5. -vAAA vAAA2: --keep-ms default to false.

  6. -all programs: add --lof-flag

2020-07-28

  1. -vAnnGene: Use MaxEntScan to predict native splice loss. Removed scSNV.

  2. -vSEG vSEG2: Check whether liability class is out of boundary. Previously it will lead to a segmentation fault.

  3. -vSEG vSEG2: Removed PopAF from the default --af.

  4. -HGVSreader: do not read dbSNP by default.

  5. -PedPro: read CPF format.

  6. -PedPro: add --gvoi

2020-07-08

  1. -vAnnGene: add g. nomenclature for insertion / deletion that has alternative alignments

  2. -vAnnGene: write OriginalIndex only when aligned_index is different from original_index

  3. -slurm.all_steps: removed a bug in reporting incidental findings

  4. -slurm.all_steps: removed a bug in pedigree analysis

2020-06-11

  1. -vAnnGene: rank consequence by FuncType.Flag, Guilt-By-Association, and Distance to transcript start site if Upstream.

  2. -vAnnGene: add --except-flag.

  3. -removed a bug in the 2020-06-09 version.

2020-06-09

  1. -data: add RED FOCS JEME PETModule

  2. -vQC: --rep uses the current file, not the replication file, as denominator to calculate call rate.

  3. -vFIN: output gene set names from small set to big set (in terms of number of genes in each set)

  4. -vAAA, vAAA2: add --keep-ms and default to yes.

  5. -victor_by_chr: remove imputed missing genotype from BEAGLE (previously do so only for SHAPEIT).

  6. -victor_by_chr: remove merging mnp from phased data.

  7. -slurm.all_steps: VAG="--biol=$GBA --no-split" by default. This is important for non-coding regions.

  8. -slurm.all_steps: add "Analysis Location"

  9. -slurm.all_steps: ignore _is_a_lwp

  10. -slurm.all_steps: changed filenames $OUT.1st $OUT.2nd to $OUT.qc1st $OUT.qc2nd.

  11. -slurm.all_steps: robust to BEAGLE without pedigree file.

  12. -slurm.all_steps: add VFT

  13. -slurm.all_steps: *.ann.del.gz do not contain genotypes anymore.

  14. -vAnnGene: add --biol option

  15. -vAnnGene: add --etg option

  16. -vAnnGene: --up changed default from 250 to 30000

  17. -vAnnGene: sort lines by gene even with --no-split. In slurm.all_steps, VAG="--no-split" will not analyze a variant twice for overlapping genes.

  18. -vAnnGene: Output SpliceUT# instead of SpliceUTR# (# is 3/5), SpliceCDS instead of SpliceSite.

  19. -vAnnGene: write the most severe outcome first even with --no-split=no.

  20. -vAnnGene: --filter changed to --filt-func. --no-filter default changed to yes.

  21. -all: penetrance is dominant by default

  22. -all: test whether data folder is valid.

  23. -add: vSEG2 program

2019-10-29

  1. -vFIN: --gba-show default changed from MAX to MEDIAN.

  2. -all: test whether data folder is valid.

  3. -slurm.all_steps and slurm.annotate: test whether users are running analysis with /path/to/VICTOR/.

  4. -slurm.all_steps and slurm.annotate: detection of genome name does not depends on terminal window size anymore.

2019-09-25

  1. -vAnnGene: read ClinVar INS of TBS or SVA

  2. -vAnnGene: remove a bug that annotate SpliceSite as Intronic(LoF)

  3. -vSEG: shrink liability classes

  4. -pedpro: add --join-gtp

  5. -pedpro: column name uses 7 characters instead of 4

  6. -all: obtain genome name from environmental variable VICTOR_GENOME before obtaining from full path of the current directory

  7. -vConvertTest: BOADICEA format now allows multiple pedigrees

  8. -vConvertTest: read_rr and create liability class by population and cohort

2019-07-06

  1. -vAnnGene: add (AlnFlag) in AltAnn.

  2. -vConvertTest: allows affection status greater than 2.

  3. - vConvertTest: pedigree file does not need to have the PedID column.

  4. - vConvertTest: removed a bug: if aff=0, may output liab<0.

  5. - vConvertTest: add --prepend-pid option and default to yes, so the website is robust to multiple PedID in a file with overlapping IndID.

2019-05-15

  1. -vAnnGene: improved alignment of InDels at splice sites.

  2. -vAAA,vAAA2: when comparing to ExAC, does not filter ExAC variant that has no AC.

  3. -vAAA,vAAA2: --xct-cov-pc changed to --xct-cov-pr. It applies to ExAC only, not study samples. And its default value is 0.1, not 0.9.

  4. -vAAA,vAAA2: --xct study_coverage_file allows 3 formats and filename allows using the character @ to represent chr#. Add --xct-chr.

  5. -vAnnGene: add the --vkr option.

  6. -slurm.all_steps: gene set analysis use GeneSet_MSigDB.gmt instead of GeneSet_MSigDB_lt50.gmt

  7. -victor_by_chr: automatically uses --add-seg=no for vFIN if $AAA contains --weight.

  8. -libfbj_genepi: add --filt-AD but default to 0.

  9. -vFIN: --vc also output MaxAF.

  10. -slurm.all_steps: write genome-wide significant results to slurm.all_steps.run_#.sig.

  11. -vFILT: can read victor.chr*.qc.ann.del.gz files.

2019-04-03

  1. -slurm.annotate: remove a bug in merging result files.

2019-03-19

  1. -Sample File: quantitative trait locus now allows any number, not just positive values.

  2. -vGrp: output gene set name as genes with variants for analysis.


2019-01-25

  1. -vQC: --rep FILE2 allows using @ to represent a set of VCFs separated by chromosomes instead of one VCF.

  2. -vFIN: add --gba-show.

  3. -vAnnGene: now the order of --swap and --flip matters.

  4. -vAnnGene: add --no-cgat to remove CG or AT SNPs no matter whether the REF is wrong.

2019-01-04

  1. -slurm.all_steps: improved pedigree file error and warning outputs.

  2. -vAnnGene: add the --swap and --flip options to correct REF errors.

  3. -vAAA,vAAA2: --write works when there are only cases or controls. Previously, it reports an error when there is no case samples.

2018-12-06

  1. -slurm.all_steps: use pedpro to fix kinship error produced by KING.

  2. -slurm.all_steps: use pedpro to check problems in the input Pedigree File.

  3. -slurm.all_steps: remove a bug that still filter variants by hard filters when VQSLOD is not calculated but par.txt says no.

  4. -Pedigree File: now always require a header row.

  5. -pedpro: --ind-wt default for all sequenced samples rather than just sequenced cases.

  6. -vAAA,vAAA2: remove a bug that --logistic does not adjust for covariates.

  7. -vAAA,vAAA2: add --my-R. Now users can run analysis with their own R codes.

  8. -vAAA,vAAA2: add --flr-R. Now users can run Firth's logistic regression with their own R codes.

  9. -vQC: output pedigree errors only when both phi and kinship are greater than 0.1. Add an option --phi-kin to control this feature.

2018-11-22

  1. -vQC: removed a bug that stops the program when there’re pedigree structure errors.

  2. -slurm.all_steps: robust to wrong kinship calculation by the KING program (it rarely happens).

  3. -vAnnGene: allows an alternative VCF format #CHROM,BP1-BP2|BP1,ID,"FromPOS",ALT. No option needed.

2018-11-21

  1. -vSEG: removed a bug that only exists in the MacOS version.

  2. -vAAA,vAAA2: when combining p-values calculated by fisher’s exact test in different cohorts, weight by the effective sample size in each cohort

  3. -victor_by_char: map files for ShapeIt is named $MAP/genetic_map_chr$CHR.txt instead of $MAP/genetic_map_chr"$CHR"_combined_b37.txt

  4. -slurm.all_steps: PED_QC/POP_QC changed parameters that are more robust for small studies.

  5. -configure file: supports --no-miss --filt-GP --filt-domGP  --filt-recGP

  6. -vAAA,vFIN,vGLR: --neg-biol=yes by default

  7. -Add a new program: pedpro

  8. -Add a new script: slurm.annotate

2018-10-11

  1. -vAnnGene: add annotation of SpliceUTR3/5. Now SpliceSite only means SpliceSite within coding regions.

2018-10-09

  1. -slurm.all_steps: add sub-analysis

  2. -vAAA,vSEG,vGrp,vFILT,vConvertVCF: add option --gene-wise-del to use gene-specific thresholds in variant filtering by deleteriousness

  3. -data_updates: add BayesDel_GST containing gene-specific thresholds for BayesDel. It’s the default parameter for --gene-wise-del.

  4. -vQC,vAAA: removed a bug (cannot recognize _iPop in the Sample File).

2018-09-27

  1. -vQC: removed a bug that leads to program crash when reading a VCF without genotypes or a VCF generated by IMPUTE2.

  2. -vAAA,vAAA2,vSEG: do not filter variant by VQSLOD or hard filter anymore.

2018-09-14

  1. -slurm.all_steps: PED_QC and SPL_PC exclude the MHC region.

  2. -slurm.all_steps: allows setting sample-wise QC cutoff values.

  3. -slurm.all_steps: does not allow SPL_PC when $SPL already has a “pop” column.

  4. -slurm.all_steps: automatically sets the parallelism option if NCPU<NCHR and PRL is not set by the user.

  5. -slurm.all_steps: use parallelism for vQC if NCPU>NCHR.

  6. -vAAA,vSEG,vGrp,vConvertVCF: add --no-mhc and --mhc-only.

2018-09-10

  1. -vQC: added --filt-impute2, --filt-GP, --filt-domGP, --filt-recGP. Now it can do QC on VCFs created by IMPUTE2.

  2. -slurm.all_steps: IMPUTE workflow and filenames changed. Also added a slurm.impute2mrg.

  3. -vAAA,vAAA2: use TMPDIR to decide where to put temporary files, instead of hard-coded as /tmp.

  4. -vAAA,vAAA2: --logistic allow --one-sided test

  5. -genotype: no more reading and filtering of GQ/DP/GP if the cutoff value is 0.

  6. -vQC,vAAA,vAAA2,vSEG,vSVA: read FORMAT at each line.

2018-09-06

  1. -vAAA,vAAA2: automatically chooses inferred population or principle components for adjustment depending on analysis type.

  2. -vAAA,vAAA2: add penalized logistic regression.

  3. -vFILT: can use --filt-del --lof-only.

  4. -slurm.all_steps: vConvertVCF and PLINK use --id-delim : so that the pedigree file allow duplicated IndID between pedigrees.

  5. -slurm.all_steps: move result files to a slurm.all_steps.run_#.results folder.

  6. -slurm.all_steps: gene set analysis employs parallelism for a fast computation.

2018-07-29

  1. -victor_by_chr: remove a bug that does not handle the situation of an empty input file while PHA is not “no”.

  2. -all programs: report LatestUpdates version.

2018-07-26

  1. -victor_by_chr: now robust to an empty VCF for phasing. This happens in small studies.

  2. -Add a program vFILT.

2018-07-09

  1. -slurm.all_steps: determines the number of threads for PROVEAN by the amount of memory instead of number of CPUs, otherwise it may crash.

2018-07-06

  1. -Some small changes to make the pipeline works for small studies.

2018-06-25

  1. -Add a new program vPROV. slurm.all_steps now automatically annotates PROVEAN if it is installed.

  2. -slurm.all_steps: change the MaxAF filter to 0.05 in reporting incidental findings.

2018-06-12 (data files updated)

  1. -vQC: add the --cohort option to do missing rate QC in each cohort separately.

  2. -vAAA, vAAA2: --min-cohort defaults to 1.

  3. -vAAA, vAAA2: when comparing to ExAC, checks for the validity of input files including .ann.del.gz and .cov.gz.

  4. -vAAA, vAAA2: add --xct-pop option to select a population in ExAC (NFE, AFR, AMR, EAS, SAS, MALE, FEMALE, etc.) for comparison.

  5. -vAAA, vAAA2: .cov.gz file format changes. The 3rd column is now the proportion of samples instead of the number of samples covered.

  6. -vBED2: removed a bug that output chromosome number (23, 24, 25) instead of chromosome names (M, X, Y).

  7. -vQC: add --hwe-controls and is default to false.

  8. -slurm.all_steps: can do phasing without parallelism.

  9. -slurm.all_steps: add parameters VAR_MISS and SPL_MISS for variant-wise missing rate and sample-wise missing rate QC, respectively.

  10. -other minor improvements

2018-06-01 (data files updated)

  1. -Bug fix in both data and programs

2018-05-29 (data files updated)

  1. -Data files: Add GRCh38 and GRCh37, in addition to hg19. See Manual for how to tell the programs which assembly to use.

  2. -all programs: VICTOR_STDERR_MUTEX changed to STDERR_MUTEX

  3. -vAAA, vAAA2: removed the --recessive option for Fisher’s exact test. Now FET detects the model from penetrance.

  4. -vQC: "The number of RVs per sample is significantly different between cases and controls" is not an error but a warning.

  5. -vAnnGene: add the --prefer option to choose the preferred gene among overlapping genes for annotation.

  6. -vDEL: “use the highest BayesDel score for LoF variants” applies only to genes selected by ExAC pLi+pRec.

  7. -vAAA,vAAA2,vAAA_GLR,vSEG,vGrp: add --lof-tol so that --lof-only analysis excludes LoF-tolerated genes.

  8. -slurm.2_ann: changed name to slurm.step2.

  9. -slurm.all_steps: use --hard-filter=yes if VQSLOD is not calculated.

  10. -vConvertVCF, vGrp, vMAF, vQC: --filt-mac will be ignored if total sample size is too small.

2018-04-13

  1. -Add the support of EPACTS. Include two new scripts, slurm.epacts and run_epacts.

  2. -slurm.all_steps: default MZ twin cutoff is changed to 0.35355 from 0.40612

  3. -slurm.all_steps: varRank does not filter variants by BayesDel.

  4. -vQC: --join-sample-qc doesn't need to be the last program option.

  5. -vGrp: remove a bug that produce an error when --pergen is not set.

  6. -vAAA, vAAA2: add Wilcoxon rank sum test --ranksum.

  7. -vAAA, vAAA2: --var-wt default to true.

  8. -vAAA, vAAA2: --min-set changed to --min-cohort.

  9. -vAAA, vAAA2: removed a bug that make FET not computed in some situations.

  10. -vAAA, vAAA2, vSEG, vGrp: do not filter variants by quality (FILTER, VQSLOD, missing rate).

2018-03-29

  1. -vAnnGene: remove a bug that results in wrong Grantham score or no Grantham annotation.

  2. -vAnnGene: for missense changes of the same position as a ClinVar variant but to a different AA, compare to missense ClinVar variant only.

  3. -vAnnGene: add the Blosum62 score annotation.

2018-03-27

  1. -vAnnDel: the default --ann is empty. Otherwise, slurm.all_steps will not work properly if AN1/An2/An3 is not set.

  2. -vAAA, vAAA2: outputs an error message and quits the program instead of crashing when the input Genotype File is truncated.

  3. -slurm.all_steps: stops running when an error occurs.

2018-03-22 (data files updated)

  1. -vAnnGene: annotate whole intron deletion as INTRONIC instead of SPLICING.

  2. -vFIN: output is more informative when reading gene-set analysis results.

  3. -slurm.all_steps: default Het/Hom cutoff changed from 2.1 to 4.

  4. -slurm.all_steps: add a step ExACnT.

  5. -slurm.all_steps: add an option QCJ.

  6. -slurm.all_steps: AN1 AN2 AN3 are no longer Annotation Files, but parameters for vAnnDel.

  7. -slurm.all_steps: CHF default changed to chr1c_noMT.

  8. -vQC: sex imputation from Y is more conservative. Added options --y-call-numb-m --y-call-rate-m --y-total-var-f --y-call-rate-f.

  9. -hg19: removed a bug in g_symbol.gz that will make gnGBA crash.

  10. -hg19: updated ClinVar to 20180225.

2018-03-12 (data files updated)

  1. -vAnnGene: INFO add the annotation of Grantham score, Exon number, and whether the variant is inside the last exon when --no-split=no.

  2. -vAAA, vAAA2: BayesDel filter will not be applied if a variant is LoF or is classified as pathogenic by ClinVar.

  3. -hg19: updated APPRIS.

2018-03-07 (data files updated)

  1. -vAAA: add --show-gt and --show-if.

  2. -vSVA: set --test to no/damaging/enhancing, no more "all".

  3. -vSVA: add --pDup-damage.

  4. -vSVA: detect and read the new XHMM format.

  5. -vAAA, vAAA2: --sv is back! This time it reads the output of “vSVA --detail” instead of “vSVA --out-lof”.

  6. -vAAA, vAAA2: --collapse, weight for each strata is not simply sample size. If controls are >4 times of cases, sample size is 5*NumberOfCases.

  7. -vQC: impute sex from X uses FdrAF only when there are 1000+ chromosomes, otherwise uses MaxAF. So, it’s robust to small samples.

  8. -vAnnGene: default --vks use ClinVar1reports.

  9. -vAnnGene: calculate Grantham score.

  10. -vAnnGene: removed a bug: now no (knClinSig=1.h) or (knClinSig=1.r) if (knClinSig=1.*) or (knClinSig=0.*) already exists.

  11. -hg19: add panel_haploinsufficiency and panel_recessive. Updated panel_incidental.

2018-02-14 (data files updated)

  1. -all programs: --nt decide whether there're enough number of cores at the end of the command line.

  2. -slurm.all_steps: add an option PRL to control number of threads in analysis.

  3. -slurm.all_steps: add gene set analysis.

  4. -slurm.all_steps: add analysis after removing carriers of variants in known genes.

  5. -slurm.all_steps: add incidental findings.

  6. -Add four programs: vAAA2, vGrp, vBED2, vMerge. The first 3 are used for gene set analysis. vMerge merge gene lists to obtain top candidates.

  7. -vAAA: output header change to AAAlbf / AAAmlp / AAApvl.

  8. -vAAA, vSEG, vGrp: --filt-del --filt-MaxAF --filt-FdrAF --filt-SplAF does not apply to LoF or ClinVar pathogenic/likely pathogenic variants.

  9. -gnGBA: default analysis is --gs.

  10. -vAAA: temporary removed the support of --sv. I am rewriting this part. Please look for it in the future updates!

  11. -hg19: updated ClinVar.

  12. -hg19: add InterPro.

  13. -hg19: include several GeneSet files.

  14. -hg19: add panel_incidental.

  15. -vAnnGene: remove a bug that keeps the old OriginalIndex when adding a new one.

  16. -other small improvements.

2018-01-18

  1. -slurm.all_steps: $OUT.vcf.gz and $OUT.qc.vcf.gz compressed by bgzip and tabix-indexed.

  2. -slurm.all_steps: prune variants and more aggressive variant QC before pedigree structure QC.

  3. -gnGBA: minimum number of genes reduced from 2 to 1.

  4. -vPC: automatically determine number of clusters from PCs, adjust for cluster prediction instead of the raw PCs.

  5. -vAAA: --collapse Fisher's exact test now adjust for covariates (combine p-values by Fisher's method weighted by sample size).

  6. -vAAA: default analysis method is now --FET (the mid-p version of Fisher’s exact test by Irwin’s rule).

  7. -vAAA: OR calculated by Mantel-Haenszel instead of crude OR.

  8. -vAAA: --filt-miss-rate=1 and --filt-miss-pv=0 by default.

  9. -vAAA: --HLR can do stratified analysis.

  10. -vSEG: --filt-miss-rate=1 by default.

  11. -vConvertVCF: --fam output two files.

  12. -vQC: --sep and --dup can be used together now.

  13. -vQC: --filt-uo-dn=0 --filt-obs-pv=0 --filt-cov-DP=0 --filt-cov-pc=0 --filt-min-DP=0 --filt-max-DP=0 by default.

  14. -vQC: add --filt-af-diff. But 0 by default.

  15. -vAnnGene: debug: now OriginalIndex for the INFO field is defined in the meta data of the output VCF.

2017-11-27

  1. -slurm.all_steps: fix a bug that halt the script when $SPL is empty and $QC1="--do-nothing". This happens when doing BayesDel annotation.

2017-10-31

  1. -vQC: allow case-insensitive string-type covariates in a Sample File.

  2. -vAAA: allow case-insensitive string-type covariates in a Sample File.

  3. -slurm.all_steps: automatically adjust for string or numeric covariates including PCs in the test of #RV/spl difference between cases and controls.

  4. -slurm.all_steps: automatically save sample file and pedigree file for logging.

  5. -slurm.all_steps: automatically remove related individuals.

  6. -slurm.all_steps: abort if there is a pedigree structure error.

  7. -vSVA: removed the option --test.

  8. -vBED: add --split.

2017-10-24

  1. -slurm.all_steps: fix a bug that makes STEP_3 fails.

  2. -slurm.all_steps: automatically save the par.txt file as part of the analysis log.

2017-10-16

  1. -slurm.steps123: changed name to slurm.all_steps

  2. -slurm.all_steps: missing rate cutoff changed to 0.005.

  3. -slurm.all_steps: does principle component analysis and determines how many principle components to be adjusted for in analysis.

  4. -slurm.all_steps: improved logging (it saves the script; it uses the --array option to name log files; it names log files after the script filename).

  5. -slurm.all_steps: automatically determines the VQSLOD cutoff.

  6. -vAAA: --collapse also calculate a p-value by Fisher’s exact test. Outputs are sorted by p-values.

  7. -vAAA: --HLR and --SSUw ignores covariates.

  8. -vAnnGene: clearer output of ClinVar annotation. It differentiate “uncertain” and “ambiguous”.

  9. -vQC: --join-sample-qc tests for the difference in #RV/Sample between cases & controls if --spl is set.

  10. -vQC: add --min-bed.

  11. -vQC: remove a bug that lead to the output vcf file not validated (the meta data for VICTOR_QC should have “Number=1”).

  12. -vFIN: add --no-zero to omit the genes or variants that have no non-reference genotypes observed in data.

  13. -vFIN: supports the vAAA outputs produced by --detail or --collapse.

  14. -victor_by_chr: $OUT_PFX.qc.vcf.gz is indexed.

  15. -Adds a script victor.sbatch for job submission.

2017-09-15

  1. -vBED: does not calculate intersection anymore if --pc=0.

  2. -vAnnGene: --vks works for StopGain too.

  3. -vAnnGene: --vks excludes conflicting records by matching variants at the protein sequence level.

  4. -vConvertTest: does not exit with a fatal error if proband is not set.

  5. -vConvertTest: PID IID can be anywhere in the input pedigree file.

  6. -vAnnGene: removed a bug that reports knClinSig=ambiguous even if the variant has no match in ClinVar.

  7. -HGVS_to_genomic: prints a header line. Adds the --no-header option.

  8. -vConvertTest: reports a fatal error if there's no carrier in the input pedigree file.

  9. -HGVS_to_genomic: adds the function to select a SNV by observation in ClinVar if a protein-level HGVS has multiple genomic interpretations.

2017-09-06

  1. -vAAA: --collapse calls haplotype=2 if both 1 and 2 have equal probability.

  2. -vSEG: proband labels are required for the IID column only, not IID+DAD+MOM.

  3. -vSEG: adds --allele-freq.

  4. -vSEG: if the penetrance file contains only one liability class model, use that for chrX too.

  5. -vConvertTest: supports standard linkage file, including pre/post makeped.

  6. -vConvertTest: supports pedigree file obtained from the BOADICEA web tool.

  7. -vConvertTest: treats successive spaces as one delimiter and trims leading white spaces for a non-BOADICEA Pedigree File.

  8. -HGVS_to_genomic: adds the default values for -x --min --step.

  9. -HGVS_to_genomic: removed a bug that leads to “cannot find MaxAF database” file even it's there.

  10. -vAnnGene: skips a line and continues if REF=ALT (previously exit with a fatal error).

  11. -vAnnGene: labels (knClinSig=ambiguous) if ambiguous (previously no label).

  12. -vSEG: automatically chooses a proband.

2017-08-31

  1. -vAnnGene: removed a bug that outputs fs for synonymous InDel.

  2. -vAnnBase: removed a bug introduced in the last version, which may add MaxAF to BayesDel twice for some InDel variants.

  3. -slurm.steps123: does not write “--rm-ind” to par.txt.

  4. -vFIN: does nothing if the input is vAAA --collapse output.

  5. -vAAA: --collapse also outputs odds ratio with Yate’s correction. Now --collapse outputs damaged haplotype counts rather than genotype counts.

2017-08-24

  1. -MaxAF: includes gnomAD, UK10K, GoNL and 1kJpn. Only variants with 5+ MAC are included, except those in gnomAD_WES.

  2. -BayesDel: fixed a bug that leads to many missing values in the database file

  3. -BayesDel: this version does not include MaxAF. Accordingly, vDEL adds an option --add-af so that you can add MaxAF to BayesDel.

  4. -All programs: array options accept EmptyString. This affects vMAF --pop.

  5. -vQC: --join-sample-qc outputs to <prefix>.sex_problem and <prefix>.sample_qc. So the --prefix option is important.

  6. -ClinVar: updated to clinvar_20170801

  7. -InDels.provean.tsv.gz: updated with more variants

  8. -vAAA: adds an option --var-wt, which is default to “no”

  9. -vConvertVCF: add an option --keep-unk

  10. -vFIN: debug: --vc not robust to variants in multiple overlapping genes

2017-07-26

  1. -victor_by_chr: log problems discovered by vAnnGene in step 1

  2. -vMAF: add --out-ms, and def to false

  3. -vMAF: --pop removed _OTH

  4. -vAnnGene: is now robust to an uncommon VCF format like 1,1097411,AC,C

  5. -vAnnGene: add --do-nothing

  6. -vAnnGene: log duplicated variants

  7. -vAnnGene: removed a bug that annotate p.S1S as missense variant

  8. -vAnnGene: removed a bug that makes output not sorted by POS

  9. -vAnnGene: removed a bug that makes the program crash when the transcription start site is at the first basepair of an exon

  10. -vDEL: removed a debug that didn't update BayesDel based on PROVEAN if BayesDel is already annotated

  11. -vDEL: improved speed

  12. -The nsfp33a.gz file in the FAQ page has been updated (previously lines were not sorted properly).

  13. -Improved the work flow in the Example 8 of the VICTOR Tutorial, annotation deleteriousness and functional consequence.

2017-07-17 (data files updated)

  1. -vAnnDel: improved speed.

  2. -vAnnDel vAnnMAF vQC HGVS_to_genomic: now robust to tabix returning a result with a wrong bp (a bug in tabix).

  3. -vSEG: treats chrX PAR as autosomal.

  4. -vAnnDel: add the option --add-ms

  5. -data/hg19: fixed the sorting of MaxAF_gUGN, snp147 and ClinVar2reports. Added @GDB_cdd (conserved domain databases).

2017-07-10

  1. -All programs: improved stderr outputs. They do not mix together even with Unix pipe and multi-processing. 

  2. -vAAA and vSEG: do not apply allele frequency filters when --vc is set.

  3. -vAnnGene: removed a bug introduced on 2017-07-04, which makes program stop if BayesDel is NaN and --vks is set.

2017-07-04

  1. -vAAA: added an option --weight.

  2. -vAAA: --write now always add a column of individual weight at the end.

  3. -vAnnGene: improved log to stderr and --log output.

  4. -vAnnGene: --no-split do not always write to INFO.

  5. -vAnnGene: improved HGVS nomenclature (H178_179insPHP should be H178_H179insPHP).

  6. -vAnnDomain: added --wr.

  7. -vAAA and vSEG: --LoF-only also filters NMD.

  8. -vDEL: removed a bug that --check-ms does not work when PROVEAN is not annotated at all.

  9. -vMAF: removed _ASJ _FIN because MaxAF should not be calculated from founder populations.

  10. -vQC: removed options --cadd-cutoff and --fmnc-cutoff.

  11. -vQC: added INFO fields AN_Founder AC_Founder AF_Founder Hom_Founder, which can be read by vMAF --pop=_Founder.

  12. -vConvertTest: can read liability class from a pedigree file.

  13. -vAnnDel: added an option --remove.

  14. -slurm.step123: small improvements.

2017-05-25

  1. -vAAA: added options --out-pv and --out-mlp.

  2. -vAnnGene: added options --gene-file, --tx-file, --genes, --txs, --no-filter. Accordingly, the Example 8 in Tutorial changed too.

  3. -victor_by_chr: replaced the flag QC_ONLY with STEP1_ONLY. But QC_ONLY is still valid for backward compatibility.

2017-05-22

  1. -Added a program HGVS_to_genomic to convert HGVS nomenclature to genomic coordinates #CHROM,POS,REF,ALT.

  2. -vAnnGene: added the option (--vks) to annotate variant of known significance (VKS). A variant will have a label knClinSig=1.a if it matches a known pathogenic VKS; or knClinSig=1.b if the variant leads to the same amino acid substitution as a VKS; or knClinSig=1.c for a missense change of the same amino acid position as a VKS but for different substitution with a higher deleteriousness score than the VKS. Variants that matches a known benign variant have a similar naming scheme, but they will be filtered out by default. This filtering can be turned off by the option --filt-benign.

  3. -The MaxAF database added GoNL.

  4. -vSPLIT and gnGBA removed a bug that doesn't read the par.txt.

  5. -Pedigree File: a proband ID can end with [p] or (p) or [proband] or (proband), or simply “proband” (case-insensitive).

  6. -vAnnGene the default value for --sv changed to yes.

  7. -vSEG do not calculate and use allele frequency from data anymore. If MaxAF is not annotated, use the default MAF.

  8. -vQC added an option --do-nothing.

  9. -vQC changed the default value of --filt-obs-maf to 0.01.

  10. -vSEG added more check points and messages.

  11. -vAAA added linear regression. And the default analysis method is now linear regression, not HLR.

  12. -All programs do not check web version automatically. They have a new option --version to invoke version checking.

  13. -Added a SLURM script template to do step 2 and 3 on one computer node with multi-processing.

  14. -Removed a bug in vDEL

2017-04-20

Major upgrades

  1. -vSEG added the option --mut-male and --mut-female to take into account de novo mutation rate in co-segregation analysis. Some genes have a high de novo mutation rate among individuals affected with a certain disease. An example is the TP53 gene for Li-Fraumeni Syndrome, which has a 7%~20% germline de novo mutation rate. This upgrade is suitable for variant classification for the genes like TP53.

  2. -vDEL calculates BayesDel from PROVEAN for InFrame InDels, and from Fathmm-MKL_noncoding + CADD + MaxAF for non-coding InDels and SNVs. BayesDel for coding SNVs is still calculated from an ensemble of individual scores like before, but the MaxAF database is updated (see below) and the individual scores now use dbNSFP v3.3 (academy), which included FATHMM, GERP++_RS, LRT, MutationAssessor, MutationTaster, Polyphen2_HDIV, Polyphen2_HVAR, PROVEAN, SIFT, SiPhy_29way, VEST3, fitCons, fathmm-MKL_coding, phastCons100way, phastCons20way, phyloP100way, and phyloP20way.

  3. -The package provides the pre-computed BayesDel scores for all possible SNVs in the entire genome. The size of this database is only 8.7 GB and the annotation is super fast due to the new vAnnBase program that is also shipped with the package. This new program can also annotate InDels using the SNV scores in affected regions. Interestingly, the performance of this strategy is better than CADD for all InDels and is very close to PROVEAN for In-Frame InDels. After integrating MaxAF, this method outperforms PROVEAN and CADD for all types of InDels.

  4. -The MaxAF database is calculated from the UK10K whole genome cohorts ALSPAC and TWINSUK, the 1000 Genomes Project, and the gnomAD. Several quality control filters (HWE p>0.000001, VQSLOD>-5.368 for SNV and >-4.208 for InDel, AN>=200) were applied before computing allele frequency. Another improvement of the MaxAF data is that both the 5'-most and 3'-most alignment of InDels are recorded. This makes the database robust to data that is not always left-normalized. See below for the reason why some data is not left-normalized intentionally.

  5. -The gene database is updated to Ensembl release 87, and refGene.txt version Mar 27, 2017.

  6. -vAnnGene rewrites the POS/REF/ALT fields based on the functional prediction of a variant. Previously, outputs are always left-normalized, a popular method to make the genomic coordinates of InDels comparable between datasets. For example, an indel could be annotated as a damaging variant by destroying a splice site if 5'-aligned or as a benign variant within an intron if 3'-aligned. In the previous version, vAnnGene annotates with the most probable functional consequence, but the output POS/REF/ALT fields are always left-normalized for easier variant matching, disregarding the functional consequence. This created a problem in subsequent deleteriousness score calculation, since most in silico programs (such as CADD) do not consider an alternative alignment for InDels. In this new version of vAnnGene, the output genomic coordinate of a variant corresponds to the functional consequence annotation. Some variant may be 5'-aligned, while others may be 3'-aligned. Although this makes variant matching less straightforward, the correct deleteriousness prediction is far more important. In addition, variant matching could be easily solved by creating a variant database with both alignments whenever possible. This is why the MaxAF database provided by VICTOR contains both left- and right-aligned InDels (see above).

  7. -vAnnGene changes the format of --pas input files. Now it allows different location types (DNA, RNA, CDS, AA, UTR3, DOWN).

  8. -vAnnGene now supports nonsense-mediated decay (NMD) annotation. vDEL treats NMD as LoF.

  9. -vAnnGene labels SpliceAltering for variants predicted by dbNSFP::dbscSNV instead of SpliceSite(LoF).

  10. -vAnnGene SpliceSite is not LoF anymore if the variant is not an LoF in an alternative transcript of the same gene.

Minor upgrades

  1. -vAnnGene splits overlapping genes into multiple lines even with the --add-info option. A new option (--no-split) is added to address the needs for not splitting variant by genes in the output.

  2. -vAnnGene has improved output. Write HGVS even for SpliceAltering/miRNAbinding/TF_binding variants. The source for SpliceAltering, miRNAbinding and TF_binding are written to Func_Type instead of Func_Detail.

  3. -vAnnGene now is robust to variants like 1,1273412,GTAGGCAGG,GC (equivalent to 1,1273413,TAGGCAGG,C) or 1,11256034,TGTGA,CGTGA (equivalent to 1,11256034,T,C).

  4. -vAnnGene updates the miRNA-binding site database to TargetScan 7.1 default_predictions.

  5. -vAnnGene option --filter now supports "coding" and "noncoding".

  6. -vAnnGene add an option --one-lett for one-letter amino acid code in HGVS, and --ter to specify code for termination.

  7. -vAnnGene add an option --log to record variants that have been removed by --filter.

  8. -vAnnDel allows an empty parameter for the --ann option, which will make the program does nothing.

  9. -vFIN output is sorted by the results. So the top genes will be listed up front.

  10. -vFIN removed a bug that doesn't add biological relevance score to the overall result for Ensembl genes.

  11. -vMAF tests for HWE before calculating the allele frequency from a cohort.

  12. -vMAF adds _ASJ to the population list, which is helpful for reading gnomAD data.

  13. -vMAF requires AN >= 200 for allele frequency calculation. This can be changed by the --min-an option.

  14. -vSVA adds the support of CLAMMs output file format.

  15. -vQC adds an option --check-ms to find the variants that need a PROVEAN or CADD annotation and write the info to a file.

  16. -vQC do hard filtering if VQSLOD does not exist. This feature can be turned off by --HardFiltIfNoVQSLOD.

  17. -vQC p-value cutoff for several QC filters changed to 0.000001.

  18. -vQC's default value for vQC --filt-cov-dp is changed to 10.

  19. -vQC removed a bug that makes the program crash when doing HWE test with an extremely large sample size.

  20. -vQC removed a bug that cause --join-sample-qc failed to read the first line of an input file.

  21. -The package's default cutoff for MaxAF variant filter is changed to 0.01.

  22. -The package's default setting for removing a variant without a VQSLOD score is "no". Instead, vQC performs hard filtering.

  23. -Some input filenames can contain @GDB as a template to be replaced with refGene or ensGene according to --gdb.

  24. -Add a new program vAnnDomain to annotate protein domains.

  25. -All programs: -h will show the final parameters after parsing par.txt and program options.

  26. -Script do_gp_by_chr became victor_by_chr. It logs parameters to stdout, and adds a step to fill in missing in silico scores.

  27. -Script victor_by_chr add a parameter AF1 to annotate user-defined allele frequency in addition to the provided MaxAF_gUG.

2016-12-24

- vDEL calculates BayesDel from CADD for non-coding regions.

2016-06-03

  1. -First release of VICTOR.