Package MultiMeta. February 19, 2015

Similar documents
Step-by-Step Guide to Advanced Genetic Analysis

Package lodgwas. R topics documented: November 30, Type Package

Package GWAF. March 12, 2015

Package QCEWAS. R topics documented: February 1, Type Package

Step-by-Step Guide to Basic Genetic Analysis

Package SMAT. January 29, 2013

FVGWAS- 3.0 Manual. 1. Schematic overview of FVGWAS

Package REGENT. R topics documented: August 19, 2015

MAGA: Meta-Analysis of Gene-level Associations

Package PedCNV. February 19, 2015

Package corclass. R topics documented: January 20, 2016

Package geneslope. October 26, 2016

Package rpst. June 6, 2017

Package GEM. R topics documented: January 31, Type Package

GWAS Exercises 3 - GWAS with a Quantiative Trait

Package dkdna. June 1, Description Compute diffusion kernels on DNA polymorphisms, including SNP and bi-allelic genotypes.

Package ridge. R topics documented: February 15, Title Ridge Regression with automatic selection of the penalty parameter. Version 2.

Package gibbs.met. February 19, 2015

Package assortnet. January 18, 2016

Package LGRF. September 13, 2015

Package globalgsa. February 19, 2015

Package poolfstat. September 14, 2018

MACAU User Manual. Xiang Zhou. March 15, 2017

Package svalues. July 15, 2018

BICF Nano Course: GWAS GWAS Workflow Development using PLINK. Julia Kozlitina April 28, 2017

Package Hapi. July 28, 2018

Package mpmi. November 20, 2016

PreMeta GENERAL INFORMATION SYNOPSIS

Package detectruns. February 6, 2018

Package DMCHMM. January 19, 2019

Package coloc. February 24, 2018

KGG: A systematic biological Knowledge-based mining system for Genomewide Genetic studies (Version 3.5) User Manual. Miao-Xin Li, Jiang Li

Package GCAI.bias. February 19, 2015

Package Mondrian. R topics documented: March 4, Type Package

Package BGData. May 11, 2017

Package samplesizelogisticcasecontrol

PreMeta GENERAL INFORMATION SYNOPSIS

Package gsalib. R topics documented: February 20, Type Package. Title Utility Functions For GATK. Version 2.1.

Package DSPRqtl. R topics documented: June 7, Maintainer Elizabeth King License GPL-2. Title Analysis of DSPR phenotypes

Package datasets.load

Step-by-Step Guide to Relatedness and Association Mapping Contents

Package CONOR. August 29, 2013

Package RAPIDR. R topics documented: February 19, 2015

Package EBglmnet. January 30, 2016

Package endogenous. October 29, 2016

Package r2d2. February 20, 2015

Package ETC. February 19, 2015

Package snpstatswriter

2 binary_coding. Index 21. Code genotypes as binary. binary_coding(genotype_warnings2na, genotype_table)

Package anidom. July 25, 2017

A short manual for LFMM (command-line version)

Package LEA. April 23, 2016

Package dlmap. February 19, 2015

Package NetWeaver. January 11, 2017

SEQGWAS: Integrative Analysis of SEQuencing and GWAS Data

Package MOJOV. R topics documented: February 19, 2015

Genetic type 1 Error Calculator (GEC)

Package NB. R topics documented: February 19, Type Package

Polymorphism and Variant Analysis Lab

Package OmicKriging. August 29, 2016

Package CorporaCoCo. R topics documented: November 23, 2017

Package wethepeople. March 3, 2013

Package CombinePortfolio

LEA: An R Package for Landscape and Ecological Association Studies

Package snplist. December 11, 2017

Package FastImputation

Package egonet. February 19, 2015

1. Summary statistics test_gwas. This file contains a set of 50K random SNPs of the Subjective Well-being GWAS of the Netherlands Twin Register

Package mvprobit. November 2, 2015

GMMAT: Generalized linear Mixed Model Association Tests Version 0.7

DeltaGen: Quick start manual

Package GLDreg. February 28, 2017

Package StVAR. February 11, 2017

Package cgh. R topics documented: February 19, 2015

The LDheatmap Package

Package svapls. February 20, 2015

Package genelistpie. February 19, 2015

Package PCGSE. March 31, 2017

Package bdots. March 12, 2018

Package GFD. January 4, 2018

Package pairsd3. R topics documented: August 29, Title D3 Scatterplot Matrices Version 0.1.0

Package modmarg. R topics documented:

PRSice: Polygenic Risk Score software - Vignette

Package seg. February 15, 2013

Package mcmcse. February 15, 2013

Package logitnorm. R topics documented: February 20, 2015

Package CSclone. November 12, 2016

Ricopili: Introdution. WCPG Education Day Stephan Ripke / Raymond Walters Toronto, October 2015

Package VSE. March 21, 2016

Package fcr. March 13, 2018

Package RYoudaoTranslate

Package multihiccompare

Package binmto. February 19, 2015

Package MultiRR. October 21, 2015

Package SimGbyE. July 20, 2009

Package cooccurnet. January 27, 2017

Quality control of array genotyping data with argyle Andrew P Morgan

Package qboxplot. November 12, qboxplot... 1 qboxplot.stats Index 5. Quantile-Based Boxplots

Package ranger. November 10, 2015

Package tpr. R topics documented: February 20, Type Package. Title Temporal Process Regression. Version

Transcription:

Type Package Package MultiMeta February 19, 2015 Title Meta-analysis of Multivariate Genome Wide Association Studies Version 0.1 Date 2014-08-21 Author Dragana Vuckovic Maintainer Dragana Vuckovic <dragana.vuckovic@burlo.trieste.it> Allows running a meta-analysis of multivariate Genome Wide Association Studies (GWAS) and easily visualizing results through custom plotting functions. The multivariate setting implies that results for each single nucleotide polymorphism (SNP) include several effect sizes (also known as ``beta coefficients'', one for each trait), as well as related variance values, but also covariance between the betas. The main goal of the package is to provide combined beta coefficients across different cohorts, together with the combined variance/covariance matrix. The method is inverse-variance based, thus each beta is weighted by the inverse of its variance-covariance matrix, before taking the average across all betas. The default options of the main function \{}code{multi_meta} will work with files obtained from GEMMA multivariate option for GWAS (Zhou & Stephens, 2014). It will work with any other output, as soon as columns are formatted to have the according names. The package also provides several plotting functions for QQ-plots, Manhattan Plots and custom summary plots. License GPL (>= 2) Imports mvtnorm,expm,ggplot2,reshape2 Depends gtable,grid Collate 'betas_plot.r' 'mhplot.r' 'multi_meta.r' 'qqplotter.r' 'Example_file_1.R' 'Example_file_2.R' 'Example_output_file.R' NeedsCompilation no Repository CRAN Date/Publication 2015-01-15 11:44:10 1

2 betas_plot R topics documented: betas_plot.......................................... 2 Example_file_1....................................... 3 Example_file_2....................................... 3 Example_output_file.................................... 4 mhplot............................................ 4 multi_meta......................................... 5 qqplotter........................................... 7 Index 8 betas_plot Summary plot of the effect sizes and their correlations for a SNP of interest betas_plot returns a pdf file containing information about the meta-analysis combined effect sizes (beta coefficients) for a chosen SNP of interest. Usage betas_plot(snp, res.file = NULL, data = NULL, trait.names = NULL, out.file = "Betas.pdf", col = NULL, orig.files = NULL, cohort.names = NULL) Arguments SNP res.file data trait.names out.file col orig.files cohort.names A SNP of interest, e.g. a SNP that is significantly associated to the analysed traits. File name of the multi_meta results containing effect sizes for the above SNP. This is an alternative to data. Object containing results from the multi_meta function and the above SNP. This is an alternative to file. Vector of analysed trait names to appear on the plot. File name for the output plot. Colours for the heat-map plot. Combinations of several colours are possible. If left blank a heat-map in scales of grey is produced. List of files with multivariate results for each cohort. Names of the cohorts included in the meta-analysis.

Example_file_1 3 Details The plot produced can be a useful tool for visualizing effect sizes across all traits, and the correlation between them. The plot will have two panels: 1. effect sizes with 95% confidence interval for each trait; 2. a heat-map showing correlations between betas. Two different types of input are allowed: a data.frame, containing the output from the multi_meta function for at least the specified SNP. This is the best choice if results have already been loaded into the R workspace. a file name containing the output from multi_meta for at least the specified SNP. The separator field is set to white space. This file can be a subset of the complete results file (suggested), e.g. a file containing only significant SNPs. Value The output is a pdf file containing the described plot. Example_file_1 Example data file 1 Example data file 1 Author(s) Dragana Vuckovic <dragana.vuckovic@burlo.trieste.it> Example_file_2 Example data file 2 Example data file 2 Author(s) Dragana Vuckovic <dragana.vuckovic@burlo.trieste.it>

4 mhplot Example_output_file Example output file This file is an example of the output obtained with multi_meta function. The input files were Example_file_1.txt and Example_file_2.txt, the command line was the one in the example (see multi_meta help) The columns are: Author(s) chr Chromosome SNP SNP name Position Position allele1 Effect allele allele0 Non-effect allele tot_af Effect-allele frequency computed on all the cohorts analysed n_pops Number of cohorts (populations) analysed pops String of 1 or 0 values indicating which populations were analysed: e.g. if the first number is 1, the first cohort was included in the analysis etc. beta_1, beta_2,..., beta_p Effect sizes for each of the p traits; in this example p=6 Vbeta_1_1, Vbeta_1_2,..., Vbeta_1_p, Vbeta_2_2,..., Vbeta_2_p,..., Vbeta_p_p Variancecovariance matrix entries (diagonal and upper triangle values only, since this matrix is symmetric) p_value P-value Dragana Vuckovic <dragana.vuckovic@burlo.trieste.it> mhplot Manhattan Plot for meta-analysis results Usage mhplot returns a pdf file containing the Manhattan plot of meta-analysis results. mhplot(res.file = NULL, data = NULL, col = c("darkgrey", "lightgrey"), out.file = "mhplot.pdf", main = "MHplot", plab = "p_value", CHRlab = "chr", POSlab = "Position", sig.p = 5e-08, sug.p = 5e-07, sep = " ")

multi_meta 5 Arguments res.file data col out.file main plab CHRlab POSlab sig.p sug.p sep File name for the file(s) containing meta-analysis results. For multiple files (e.g. one file for each chromosome) the special character "*" is allowed. This is an alternative to data. Dataset containing meta-analysis results. This is an alternative to file, if results are already loaded in the R workspace. Choice of two colours for the plot. They will be alternating for different chromosomes. File name for the output. Title to appear on plot. p-values label i.e. column name for the p-values column. Chromosome label i.e. column name for the chromosome numbers column. Position label i.e. column name for the position numbers column. Significant p-values level. Suggestive p-values level. Separator used in file. Default is white space. Details Value The function is useful for a quick overview of meta-analysis results. Two different types of input are allowed: a data frame containing chromosome, position and p-values to be plotted. a file name for retrieving information from file. Note that separator is set to white space, can be changed accordingly if needed. Special character "*" is allowed for selecting more than one file (e.g. in case there is one file for each chromosome). The output is a pdf file containing the Manhattan Plot. multi_meta Meta-analysis of multivariate GWAS results Usage multi_meta returns the meta-analysis results for multivariate GWAS across different cohorts. multi_meta(files = c(), N = c(), output.file = "Meta_Results.txt", size.chunks = 5e+06, min.pop = 2, sep = "\t")

6 multi_meta Arguments files N output.file size.chunks min.pop sep A vector containing the names of the results files to meta-analyse. These can be outputs from GEMMA multivariate analysis or similar (see Details). Furthermore they can be single-chromosome or genome-wide results. A vector containing sample sizes for each of the above files. This parameter is optional and is only required for computing the overall allele frequency. The name of the output file. Size of each chunk to be read and processed. Default is 5,000,000 (5 Mb). This size will require very low memory usage. Increase this parameter if more memory is allocated or if the number of cohorts is limited. Read more about the chunks in Details. Minimum number of populations required per SNP to compute meta-analysis. Default is 2, it can be any number up to the total number of cohorts analysed. Separator for reading input files. Details This function applies an inverse-variance based method to meta-analyse multivariate GWAS results. In particular, given n different cohorts, for which p phenotypes have been tested for genome-wide association, the results for each cohort will have p different effect size coefficients i.e. beta values (one per each phenotype) and a variance/covariance pxp matrix representing beta s variances and covariances. In particular, the function is built to consider the output from the GEMMA software multivariate association testing. If your output is not produced with GEMMA, the function works on any results file containing the following column names: chr Chromosome ps Position rs SNP name allele1 Effect allele allele0 Non-effect allele af Effect-allele frequency beta_1, beta_2,..., beta_p Effect sizes for each of the p traits Vbeta_1_1, Vbeta_1_2,..., Vbeta_1_p, Vbeta_2_2,..., Vbeta_2_p,..., Vbeta_p_p variancecovariance matrix entries (diagonal and upper triangle values only, since this matrix is symmetric) The function divides input files into chunks based on position. Only one chunk at a time is read and analysed; thus a limited amount of data is loaded in the workspace at one given time. Default chunk dimension is 5 Mb for which low memory is required (<250 MB for 2 cohorts). If you have larger RAM availability, sparse markers or a limited number of cohorts, change chunks dimension from the command line.

qqplotter 7 Examples file1=system.file("extdata", "Example_file_1.txt", package="multimeta") file2=system.file("extdata", "Example_file_2.txt", package="multimeta") multi_meta(files=c(file1,file2), N=c(1200,600), sep=" ", output.file="output_from_running_example.txt") qqplotter Quantile-quantile plot for observed vs. expected p-values Usage qqplotter returns a pdf file containing the QQ-plot for a given set of p-values Arguments qqplotter(p_values = NULL, res.file = NULL, p.num.col = NULL, sep = " ", out.file = "QQplot.pdf", title = "") p_values res.file p.num.col sep title out.file A vector or a column in a data-set containing p-values to plot. This is an alternative to file. File name of the file containing p-values to retrieve. This alternative does not require loading the results and is an alternative to the p_values parameter. Number indicating which column of the file contains p-values. Specify only if you are using the file option. File separator to be used when reading file. Default is white space. Title to appear on the plot. File name for the output plot. Details Value The function is useful for comparing expected and observed distributions of statistics arising from genome-wide testing. Two different types of input are allowed: an object such as vector or data-frame column, containing p-values; a file name and the column number for retrieving p-values from file. Note that separator is set to white space, can be changed accordingly if needed. The special character "*" is allowed for selecting more than on file (e.g. in case there is one file for each chromosome) but the p-values column position must be the same for all files. The output will be a pdf file containing the QQplot.

Index Topic datasets Example_file_1, 3 Example_file_2, 3 Example_output_file, 4 Topic data Example_file_1, 3 Example_file_2, 3 Example_output_file, 4 betas_plot, 2 Example_file_1, 3 Example_file_2, 3 Example_output_file, 4 mhplot, 4 multi_meta, 5 qqplotter, 7 8