You signed in with another tab or window. Reload to refresh your session.You signed out in another tab or window. Reload to refresh your session.You switched accounts on another tab or window. Reload to refresh your session.Dismiss alert
Copy file name to clipboardExpand all lines: README.Rmd
+17-19Lines changed: 17 additions & 19 deletions
Original file line number
Diff line number
Diff line change
@@ -28,7 +28,9 @@ knitr::opts_chunk$set(
28
28
29
29
## Introduction
30
30
31
-
The goal of `ggcoverage` is simplify the process of visualizing omics coverage. It contains three main parts:
31
+
The goal of `ggcoverage` is to visualize coverage tracks from genomics, transcriptomics or proteomics data. It contains functions to load data from BAM, BigWig, BedGraph, txt, or xlsx files, create genome/protein coverage plots, and add various annotations including base and amino acid composition, GC content, copy number variation (CNV), genes, transcripts, ideograms, peak highlights, HiC contact maps, contact links and protein features. It is based on and integrates well with `ggplot2`.
32
+
33
+
It contains three main parts:
32
34
33
35
***Load the data**: `ggcoverage` can load BAM, BigWig (.bw), BedGraph, txt/xlsx files from various omics data, including WGS, RNA-seq, ChIP-seq, ATAC-seq, proteomics, et al.
34
36
***Create omics coverage plot**
@@ -44,12 +46,9 @@ The goal of `ggcoverage` is simplify the process of visualizing omics coverage.
44
46
***link annotation**: Visualize genome coverage with contacts
45
47
***peotein feature annotation**: Visualize protein coverage with features
46
48
47
-
`ggcoverage` utilizes `ggplot2` plotting system, so its usage is **ggplot2-style**!
48
-
49
-
50
49
## Installation
51
50
52
-
`ggcoverage` is an R package distributed as part of the [CRAN](https://cran.r-project.org/).
51
+
`ggcoverage` is an R package distributed as part of the [CRAN repository](https://cran.r-project.org/).
53
52
To install the package, start R and enter one of the following commands:
54
53
55
54
```{r install, eval = FALSE}
@@ -61,9 +60,9 @@ install.package("remotes")
61
60
remotes::install_github("showteeth/ggcoverage")
62
61
```
63
62
64
-
In general, it is **recommended** to install from [Github repository](https://github.com/showteeth/ggcoverage) (update more timely).
63
+
In general, it is **recommended** to install from the [Github repository](https://github.com/showteeth/ggcoverage) (updated more regularly).
65
64
66
-
Once `ggcoverage` is installed, it can be loaded as every other package:
65
+
Once `ggcoverage` is installed, it can be loaded like every other package:
67
66
68
67
```{r library, message = FALSE, warning = FALSE}
69
68
library("ggcoverage")
@@ -74,14 +73,14 @@ library("ggcoverage")
74
73
`ggcoverage` provides two [vignettes](https://showteeth.github.io/ggcoverage/):
75
74
76
75
***detailed manual**: step-by-step usage
77
-
***customize the plot**: customize the plot and add additional layer
76
+
***customize the plot**: customize the plot and add additional layers
78
77
79
78
80
79
## RNA-seq data
81
80
82
81
### Load the data
83
82
84
-
The RNA-seq data used here are from [Transcription profiling by high throughput sequencing of HNRNPC knockdown and control HeLa cells](https://bioconductor.org/packages/release/data/experiment/html/RNAseqData.HNRNPC.bam.chr14.html), we select four sample to use as example: ERR127307_chr14, ERR127306_chr14, ERR127303_chr14, ERR127302_chr14, and all bam files are converted to bigwig file with [deeptools](https://deeptools.readthedocs.io/en/develop/).
83
+
The RNA-seq data used here is from [Transcription profiling by high throughput sequencing of HNRNPC knockdown and control HeLa cells](https://bioconductor.org/packages/release/data/experiment/html/RNAseqData.HNRNPC.bam.chr14.html). We select four samples to use as example: `ERR127307_chr14`, `ERR127306_chr14`, `ERR127303_chr14`, `ERR127302_chr14`, and all bam files were converted to bigwig files with [deeptools](https://deeptools.readthedocs.io/en/develop/).
85
84
86
85
Load metadata:
87
86
@@ -125,7 +124,7 @@ mark_region
125
124
126
125
### Load GTF
127
126
128
-
To add **gene annotation**, the gtf file should contain **gene_type** and **gene_name** attributes in **column 9**; to add **transcript annotation**, the gtf file should contain **transcript_name** attribute in **column 9**.
127
+
To add **gene annotation**, the gtf file should contain **gene_type** and **gene_name** attributes in **column 9**; to add **transcript annotation**, the gtf file should contain a **transcript_name** attribute in **column 9**.
129
128
130
129
```{r load_gtf}
131
130
gtf_file <-
@@ -230,14 +229,14 @@ basic_coverage +
230
229
231
230
### Add transcript annotation
232
231
233
-
**In "loose" stype (default style; each transcript occupies one line)**:
232
+
**In "loose" style (default style; each transcript occupies one line)**:
For base and amino acid annotation, we have following default color schemes, you can change with `nuc.color` and `aa.color` parameters.
438
+
For base and amino acid annotation, the package comes with the following default color schemes. Color schemes can be changed with `nuc.color` and `aa.color` parameters.
440
439
441
-
Default color scheme for base annotation is `Clustal-style`, more popular color schemes is available [here](https://www.biostars.org/p/171056/).
440
+
THe default color scheme for base annotation is `Clustal-style`, more popular color schemes are available [here](https://www.biostars.org/p/171056/).
The ChIP-seq data used here are from [DiffBind](https://bioconductor.org/packages/release/bioc/html/DiffBind.html), I select four sample to use as example: Chr18_MCF7_input, Chr18_MCF7_ER_1, Chr18_MCF7_ER_3, Chr18_MCF7_ER_2, and all bam files are converted to bigwig file with [deeptools](https://deeptools.readthedocs.io/en/develop/).
589
+
The ChIP-seq data used here is from [DiffBind](https://bioconductor.org/packages/release/bioc/html/DiffBind.html). Four samples are selected as examples: `Chr18_MCF7_input`, `Chr18_MCF7_ER_1`, `Chr18_MCF7_ER_3`, `Chr18_MCF7_ER_2`, and all bam files were converted to bigwig files with [deeptools](https://deeptools.readthedocs.io/en/develop/).
591
590
592
591
Create metadata:
593
592
@@ -679,7 +678,7 @@ The Hi-C method maps chromosome contacts in eukaryotic cells.
679
678
For this purpose, DNA and protein complexes are cross-linked and DNA fragments then purified.
680
679
As a result, even distant chromatin fragments can be found to interact due to the spatial organization of the DNA and histones in the cell. Hi-C data shows these interactions for example as a contact map.
681
680
682
-
The Hi-C data are from [pyGenomeTracks: reproducible plots for multivariate genomic datasets](https://academic.oup.com/bioinformatics/article/37/3/422/5879987?login=false).
681
+
The Hi-C data is taken from [pyGenomeTracks: reproducible plots for multivariate genomic datasets](https://academic.oup.com/bioinformatics/article/37/3/422/5879987?login=false).
683
682
684
683
The Hi-C matrix visualization is implemented by [`HiCBricks`](https://github.com/koustav-pal/HiCBricks).
685
684
This package needs to be installed separately (it is only 'Suggested' by `ggcoverage`).
@@ -785,7 +784,7 @@ basic_coverage +
785
784
786
785
## Mass spectrometry protein coverage
787
786
788
-
[Mass spectrometry (MS) is an important method for the accurate mass determination and characterization of proteins, and a variety of methods and instrumentations have been developed for its many uses](https://en.wikipedia.org/wiki/Protein_mass_spectrometry). After MS, we can check the coverage of protein to check the quality of the data and find the reason why the segment did not appear and improve the experiment.
787
+
[Mass spectrometry](https://en.wikipedia.org/wiki/Protein_mass_spectrometry) (MS) is an important method for the accurate mass determination and characterization of proteins, and a variety of methods and instruments have been developed for its many uses. With `ggcoverage`, we can easily inspect the peptide coverage of a protein in order to learn about the quality of the data.
789
788
790
789
### Load coverage
791
790
@@ -855,6 +854,5 @@ protein_coverage +
855
854
```
856
855
857
856
## Code of Conduct
858
-
859
-
Please note that the `ggcoverage` project is released with a [Contributor Code of Conduct](https://contributor-covenant.org/version/2/0/CODE_OF_CONDUCT.html). By contributing to this project, you agree to abide by its terms.
860
857
858
+
Please note that the `ggcoverage` project is released with a [Contributor Code of Conduct](https://contributor-covenant.org/version/2/0/CODE_OF_CONDUCT.html). By contributing to this project, you agree to abide by its terms.
0 commit comments