Man pages for elsayed-lab/hpgltools
A pile of (hopefully) useful R functions

add_binary_statesAdd binary state information to the scd.
add_clonotype_annotationsAdd VDJ information using some code I found.
add_conditional_nasReplace 0 with NA if not all entries for a given condition...
all_adjustersCombine all surrogate estimators and batch correctors into...
all_gprofilerRun simple_gprofiler on every table from...
all_ontology_searchesPerform ontology searches given the results of a differential...
all_pairwisePerform limma, DESeq2, EdgeR pairwise analyses.
annotate_networkUse grep to add a vector of annotations/colors to a network.
annotate_network_dfA version of annotate_network, but which uses a dataframe as...
annotation-expt-methodA getter for the annotation databased used to create an...
annotation-set-expt-ANY-methodA setter for the annotation database used to create an...
assay-ExpressionSet-ANY-methodA getter to pull the assay data from an ExpressionSet.
assay-expt-ANY-methodA getter to pull the assay data from an expt.
assay-set-ExpressionSet-ANY-methodA setter to put the assay data into an ExpressionSet.
assay-set-expt-ANY-methodA setter to put the assay data into an expt.
backup_expression_dataKeep a copy of the original state of an expressionset in case...
backup_expression_data-ExpressionSet-methodBackup the state of an expressionSet.
backup_expression_data-SummarizedExperiment-methodBackup the state of an SummarizedExperiment.
backup_fileMake a backup of an existing file with n revisions, like VMS!
base_sizeThe following sets the ggplot2 default text size.
basic_pairwiseThe simplest possible differential expression method.
batch_countsPerform different batch corrections using limma, sva, ruvg,...
binary_pairwisePerform all_pairwise only using deseq/edger.
bioc_allGrab a copy of all bioconductor packages and install them by...
calculate_auccCalculate the Area under the Concordance Curve.
cbcb_batchA function suggested by Hector Corrada Bravo and Kwame Okrah...
cbcb_combatA modified version of comBatMod.
cbcb_filter_countsFilter low-count genes from a data set using cpm data and a...
cheap_tmSimplified TM calculator
check_circosValidation function when creating a circos class.
check_includesConvert a vector of yes/no by DE method to a list.
check_metadata_yearFigure out when mappings were performed by their timestamp
check_plot_scaleLook at the range of the data for a plot and use it to...
check_xlsx_worksheetCreate the named worksheet in a workbook, this function was...
choose_basic_datasetAttempt to ensure that input data to basic_pairwise() is...
choose_binom_datasetA sanity check that a given set of data is suitable for...
choose_datasetChoose a suitable data set for Edger/DESeq
choose_limma_datasetA sanity check that a given set of data is suitable for...
choose_modelTry out a few experimental models and return a likely working...
choose_sequence_regionsGiven a named vector of fun regions, make a dataframe which...
circos_arcWrite arcs between chromosomes in circos.
circos_check_chromosomesMake sure I haven't mixed and matched genomes.
circos-classCreate a class for circos data
circos_heatmapWrite tiles of arbitrary heat-mappable data in circos.
circos_histWrite histograms of arbitrary floating point data in circos.
circos_ideogramCreate the description of chromosome markings.
circos_karyotypeCreate the description of (a)chromosome(s) for circos.
circos_makeWrite a simple makefile for circos.
circos_plus_minusWrite tiles of bacterial ontology groups using the categories...
circos_prefixWrite the beginning of a circos configuration file.
circos_suffixWrite the end of a circos master configuration.
circos_ticksCreate the ticks for a circos plot.
circos_tileWrite tiles of arbitrary categorical point data in circos.
classify_n_timesRerun a model generator and classifier on a training/testing...
classify_variantsGiven a pile of variants from freebayes and friends, make a...
clear_sessionClear an R session, this is probably unwise given what I have...
cleavage_histogramMake a histogram of how many peptides are expected at every...
cluster_treesTake clusterprofile group data and print it on a tree as per...
colData-ExpressionSet-methodA getter to pull the sample data from an ExpressionSet.
colData-expt-methodA getter to pull the sample data from an expt.
colData-set-ExpressionSet-ANY-methodA setter to put the sample data into an ExpressionSet.
colData-set-expt-ANY-methodA setter to put the sample data into an expt.
color_intTranslate the hexadecimal color codes to three decimal...
colorsGet the colors from an expt.
colors-expt-methodA getter to pull the colors from an expt.
colors-setSet the colors to an expt.
colors-set-expt-methodA setter to put the colors into an expt.
colors-set-SummarizedExperiment-methodA setter to put the colors into a SummarizedExperiment.
colors-SummarizedExperiment-methodA getter to pull the colors from a SummarizedExperiment.
column_assignmentdata.table's funky column assignment operator
combine_de_tablesCombine portions of deseq/limma/edger table output.
combine_exptsTake two expressionsets and smoosh them together.
combine_extracted_plotsGather data required to make MA/Volcano plots for pairwise...
combine_mapped_tableCombine data taken from map_keepers() into a single large...
combine_single_de_tableGiven a limma, edger, and deseq table, combine them into one.
compare_batchesAttempt to compare the results from the various batch/sv...
compare_de_resultsCompare the results of separate all_pairwise() invocations.
compare_de_tablesUse plot_linear_scatter to compare to de tables.
compare_go_searchesCompare the results from different ontology tools
compare_logfc_plotsCompare logFC values from limma and friends
compare_pc_svIncomplete function to compare PCs and SVs.
compare_significant_contrastsImplement a cleaner version of 'subset_significants' from...
compare_surrogate_estimatesPerform a comparison of the surrogate estimators demonstrated...
concatenate_runsSum the reads/gene for multiple sequencing runs of a single...
convert_countsPerform a cpm/rpkm/whatever transformation of a count table.
convert_gsc_idsUse AnnotationDbi to translate geneIDs from type x to type y.
convert_idsChange gene IDs to the format expected by gsva using an...
cordistSimilarity measure which combines elements from Pearson...
correlate_de_tablesSee how similar are results from limma/deseq/edger/ebseq.
count_clonotype_by_clusterAdd a df of clonotype observations by cell cluster to @misc...
count_expt_snpsGather snp information for an expt
count_nmerCount n-mers in a given data set using Biostrings
count_nmer-character-methodCount nmers given a filename instead of genome object.
counts_from_surrogatesA single place to extract count tables from a set of...
cp_optionsSet up appropriate option sets for clusterProfiler
create_exptWrap bioconductor's expressionset to include some extra...
create_partitionsUse createDataPartition to create test/train sets and massage...
create_scdCreate a combined seurat object from a sample sheet.
create_seCreate a SummarizedExperiment given some metadata
default_properInvoke PROPER and replace its default data set with data of...
deparse_go_valueExtract more easily readable information from a GOTERM datum.
deseq2_pairwiseSet up model matrices contrasts and do pairwise comparisons...
deseq_lrtBring together some of the likelihood ratio test analyses.
deseq_pairwisedeseq_pairwise() Because I can't be trusted to remember '2'.
deseq_try_svGiven a set of surrogate variables from sva and friends, try...
de_vennCreate venn diagrams describing how well deseq/limma/edger...
disjunct_pvaluesTest for infected/control/beads - a placebo effect?
dispatch_count_linesCount the number of lines in an input file spec and add it to...
dispatch_csv_searchPull some information from a csv/tsv file.
dispatch_fasta_lengthsGet the lengths of sequences from a fasta file.
dispatch_filename_searchPull out the filename matching an input spec
dispatch_gcPull GC content into the metadata sheet.
dispatch_metadata_extractThis is basically just a switch and set of regexes for...
dispatch_metadata_ratioGiven two metadata columns, print a ratio.
dispatch_regex_searchGeneric dispatcher to hunt down useful information from logs.
divide_seqExpress a data frame of counts as reads per pattern per...
do_batchActually runs the batch method, this more than anything shows...
do_pairwiseGeneralize pairwise comparisons
dopardopar
dot-dataTaken from Nathan Eastwood to help using mutate and friends.
do_topgoAn attempt to make topgo invocations a bit more standard.
download_gbkA genbank accession downloader scurrilously stolen from ape.
download_microbesonline_filesDownload the various file formats from microbesoline.
dream_pairwiseSet up a model matrix and set of contrasts for pairwise...
ebseq_fewInvoke EBMultiTest() when we do not have too many conditions...
ebseq_pairwiseSet up model matrices contrasts and do pairwise comparisons...
ebseq_pairwise_subsetPerform pairwise comparisons with ebseq, one at a time.
ebseq_size_factorsChoose the ebseq normalization method to apply to the data.
ebseq_twoThe primary function used in my EBSeq implementation.
edger_pairwiseSet up a model matrix and set of contrasts to do pairwise...
enrichResultThe enrichResult class.
exclude_genes_exptA temporary alias to subset_genes
exprs-expt-methodA getter to pull the expression data from an expt.
exprs-set-ExpressionSet-data.frame-methodA setter to put the expression data into an expt.
exprs-set-expt-ANY-methodA setter to put the expression data into an expt.
exprs-set-SummarizedExperiment-ANY-methodA setter to put the expression data to a...
exprs-SummarizedExperiment-methodA getter to pull the expression data from a...
exptAn expt is an ExpressionSet superclass with a shorter name.
extract_abundant_genesExtract the sets of genes which are significantly more...
extract_coefficient_scatterPerform a coefficient scatter plot of a...
extract_de_plotsMake a MA plot of some limma output with pretty colors and...
extract_goExtract a set of geneID to GOID mappings from a suitable data...
extract_interesting_goseqFilter a goseq significance search
extract_keepersWhen a list of 'keeper' contrasts is specified, extract it...
extract_lengthsTake gene/exon lengths from a suitable data source...
extract_mayu_pps_fdrRead output from mayu to get the IP/PP number corresponding...
extract_metadataPull metadata from a table (xlsx/xls/csv/whatever)
extract_msraw_dataRead a bunch of mzXML files to acquire their metadata.
extract_mzML_scansParse a mzML file and return the relevant data.
extract_mzXML_scansParse a mzXML file and return the relevant data.
extract_peprophet_dataGet some data from a peptideprophet run.
extract_pyprophet_dataRead a bunch of scored swath outputs from pyprophet to...
extract_scan_dataRead a mzML/mzXML file and extract from it some important...
extract_siggenesAlias for extract_significant_genes because I am dumb.
extract_significant_genesExtract the sets of genes which are significantly up/down...
factor_rsquaredCollect the r^2 values from a linear model fitting between a...
fData-expt-methodA getter to pull the gene annotation data from an expt.
fData-set-expt-ANY-methodA setter to put the gene annotation data into an expt.
fData-set-SummarizedExperiment-ANY-methodA setter to put the gene annotation data into a...
fData-SummarizedExperiment-methodA getter to pull the gene annotation data from a...
features_greater_thanCount the number of features(genes) greater than x in a data...
features_in_single_conditionI want an easy way to answer the question: what features are...
features_less_thanDo features_greater_than() inverted!
filter_countsCall various count filters.
filter_scdPerform a series of filters on a single-cell dataset.
find_subseq_target_tempFind a subsequence with a target PCR temperature.
find_working_datasetSearch a mart for a usable dataset.
find_working_martFind a functional biomart instance.
flanking_sequenceExtract sequence flanking a set of annotations (generally...
gather_cp_genesCollect gene IDs from a table and make them readable.
gather_eupath_utrs_paddingGiven an eupathdb species lacking UTR boundaries, extract an...
gather_genes_orgdbUse the orgdb instances from clusterProfiler to gather...
gather_massesUse BRAIN to find the peptide mass from a sequence.
gather_ontology_genesGiven a set of goseq data from simple_goseq(), make a list of...
gather_preprocessing_metadataAutomagically fill in a sample sheet with the results of the...
gather_utrs_paddingTake a BSgenome and data frame of chr/start/end/strand,...
gather_utrs_txdbGet UTR sequences using information provided by TxDb and...
genefilter_cv_countsFilter genes from a dataset outside a range of variance.
genefilter_kofa_countsFilter low-count genes from a data set using genefilter's...
genefilter_pofa_countsFilter low-count genes from a data set using genefilter's...
generate_expt_colorsSet up default colors for a data structure containing usable...
generate_nn_groupsGiven an n-dimensional matrix, try some KNN-esque clustering...
genomic_kmer_distUse ape to generate a distance based nj tree from fasta...
genoplot_chromosomeTry plotting a chromosome (region)
get_abundant_genesFind the set of most/least abundant genes according to limma...
get_backup_expression_dataExtract the backup copy of an expressionset from an expt.
get_backup_expression_data-ExpressionSet-methodGet the backup data from an ExpressionSet.
get_backup_expression_data-SummarizedExperiment-methodGet the backup data from a SummarizedExperiment.
getEdgeWeightsPlot the ontology DAG.
get_expt_colorsGet a named vector of colors by condition.
get_genesizesGrab gene length/width/size from an annotation database.
get_git_commitGet the current git commit for hpgltools
get_group_gsva_meansCreate dataframe which gets the maximum within group mean...
get_gsvadb_namesExtract the GeneSets corresponding to the provided name(s).
get_identifierGet an Identifier function from a shorthand name.
get_individual_snpsExtract the observed snps unique to individual categories in...
get_kegg_compoundsGather all Compounds from all pathways for a given species.
get_kegg_genesExtract the set of geneIDs matching pathways for a given...
get_kegg_orgnSearch KEGG identifiers for a given species name.
get_kegg_subProvide a set of simple substitutions to convert geneIDs from...
get_microbesonline_taxidExtract microbesonline taxon IDs without having to click on...
get_msigdb_metadataCreate a metadata dataframe of msigdb data, this hopefully...
get_pairwise_gene_abundancesA companion function for get_abundant_genes()
get_plot_columnsA small rat's nest of if statements intended to figure out...
get_proportion_snp_setsCreate all possible sets of variants by sample (types).
get_resAttempt to get residuals from tsne data
get_sig_genesGet a set of up/down differentially expressed genes.
get_sig_gsva_categoriesAttempt to score the results from simple_gsva()
get_snp_setsCollect variants associated with specific conditions.
get_yyyymm_commitFind the git commit closest to the given yyyymmdd.
gff2grRewrite a gff file as a granges with full seqinfo if...
gff2irangeExtract annotation information from a gff file into an irange...
ggplotly_urlAdd a little logic to ggplotly to simplify adding clicky...
ggpltSimplify plotly ggplot conversion so that there are no...
godefGet a go long-form definition from an id.
golevGet a go level approximation from an ID.
golevelGet a go level approximation from a set of IDs.
golevel_dfExtract a dataframe of golevels using getGOLevel() from...
goontGet a go ontology name from an ID.
gosecGet a GO secondary ID from an id.
goseq2enrichCreate a clusterProfiler compatible enrichResult data...
goseq_msigdbPass MSigDB categorical data to goseq and run it.
goseq_tableEnhance the goseq table of gene ontology information.
goseq_treesMake fun trees a la topgo from goseq data.
gostats2enrichCreate a clusterProfiler compatible enrichResult data...
gostats_keggUse gostats() against kegg pathways.
gostats_treesTake gostats data and print it on a tree as topGO does.
gosynGet a go synonym from an ID.
gotermGet a go term from ID.
gotestTest GO ids to see if they are useful.
gprofiler2enrichRecast gProfiler data to the output class produced by...
grapes-colon-colon-colon-grapesR CMD check is super annoying about :::.
graph_metricsMake lots of graphs!
group_mean_cds_lengthAverage the cds length over known transcripts for a single...
guess_orgdb_keytypeIterate over keytypes looking for matches against a set of...
heatmap.3a minor change to heatmap.2 makes heatmap.3
hpgl_arescoreImplement the arescan function in R
hpgl_corWrap cor() to include robust correlations.
hpgl_distBecause I am not smart enough to remember t()
hpgl_filter_countsFilter low-count genes from a data set using cpm data and a...
hpgl_GOplotA minor hack of the topGO GOplot function.
hpgl_GroupDensityA hack of topGO's groupDensity()
hpgl_log2cpmConverts count matrix to log2 counts-per-million reads.
hpgl_normNormalize a dataframe/expt, express it, and/or transform it
hpgl_padjustWrap p.adjust to add IHW adjustments as an option.
hpgl_qshrinkA hacked copy of Kwame's qsmooth/qstats code.
hpgl_qstatsA hacked copy of Kwame's qsmooth/qstats code.
hpgl_rpkmReads/(kilobase(gene) * million reads)
hpgltoolshpgltools: a suite of tools to make our analyses easier
hpgl_voomA slight modification of limma's voom().
hpgl_voomweightedA minor change to limma's voom with quality weights to...
iDAGeneric method to input data to iDA
iDA-matrix-methodSet method for matrix to input data to iDA
ihw_adjustMake sure the outputs from limma and friends are in a format...
import_deseqTry to add data to DESeq in a flexible fashion. This...
import_edgerImport tximport information into edgeR.
impute_exptImpute missing values using code from DEP reworked for...
init_xlsxInitialize an xlsx file with a little bit of logic to make...
intersect_signaturesTake a result from simple_gsva(), a list of gene IDs, and...
intersect_significantFind the sets of intersecting significant genes
kegg_vector_to_dfConvert a potentially non-unique vector from kegg into a...
limma_pairwiseSet up a model matrix and set of contrasts for pairwise...
load_annotationsUse one of the load_*_annotations() functions to gather...
load_biomart_annotationsExtract annotation information from biomart.
load_biomart_goExtract gene ontology information from biomart.
load_biomart_orthologsUse biomart to get orthologs between supported species.
load_genbank_annotationsGiven a genbank accession, make a txDb object along with...
load_gff_annotationsExtract annotation information from a gff file into a df
load_gmt_signaturesLoad signatures from either a gmt file, xml file, or directly...
load_kegg_annotationsCreate a data frame of pathways to gene IDs from KEGGREST
loadmeLoad a backup rdata file
load_microbesonline_annotationsSkip the db and download all the text annotations for a given...
load_microbesonline_goExtract the set of GO categories by microbesonline locus
load_orgdb_annotationsLoad organism annotation data from an orgdb sqlite package.
load_orgdb_goRetrieve GO terms associated with a set of genes.
load_trinotate_annotationsRead a csv file from trinotate and make an annotation data...
load_trinotate_goRead a csv file from trinotate and extract ontology data from...
load_uniprot_annotationsDownload the txt uniprot data for a given accession/species.
load_uniprot_goExtract ontology information from a uniprot dataframe.
local_get_valuePerform a get_value for delimited files
make_assembly_specGenerate an assembly annotation specification for use by...
make_dnaseq_specGenerate a DNASeq specification for use by...
make_gsc_from_abundantGiven a pairwise result, make a gene set collection.
make_gsc_from_idsCreate a gene set collection from a set of arbitrary IDs.
make_gsc_from_pairwiseGiven a pairwise result, make a gene set collection.
make_id2gomapMake a go mapping from IDs in a format suitable for topGO.
make_kegg_dfUse pathfindR to get a dataframe of KEGG IDs.
make_limma_tablesWrites out the results of a limma search using toptable().
make_pairwise_contrastsRun makeContrasts() with all pairwise comparisons.
make_pombe_exptCreate a Schizosaccharomyces cerevisiae expt.
make_pombe_seAnalagous function to make_pombe_expt()
make_rnaseq_specGenerate a RNASeq specification for use by...
make_simplified_contrast_matrixCreate a contrast matrix suitable for MSstats and similar...
make_tx_gene_mapI keep messing up the creation of the salmon trancript to...
map_keepersFind the correct tables given a set of definitions of desired...
map_kegg_dbsMaps KEGG identifiers to ENSEMBL gene ids.
map_orgdb_idsMap AnnotationDbi keys from one column to another.
mean_by_bioreplicateAn attempt to address a troubling question when working with...
mean_by_factorRuns median_by_factor with fun set to 'mean'.
median_by_factorCreate a data frame of the medians of rows by a given factor...
mesgmessage() but with a verbose flag.
model_testMake sure a given experimental factor and design will play...
my_identifyAUBlockscopy/paste the function from SeqTools and figure out where it...
my_isvaThere are some funky scoping problems in isva::DoISVA().
mymakeContrastsA copy of limma::makeContrasts() with special sauce.
myretrieveKGMLA couple functions from KEGGgraph that have broken
my_runsimsA version of PROPER:::runsims which is (hopefully) a little...
network_from_matrixGiven a matrix of scores (bit score, e-value, etc), create an...
noiseq_pairwisePerform pairwise comparisons using noiseq.
normalizeSimplified and ideally improved normalization function
normalize_countsPerform a simple normalization of a count table.
normalize_exptNormalize the data of an expt object. Save the original...
normalize_seNormalize a SummarizedExperiment and think about how I want...
notes-expt-methodA getter to pull the notes an expt.
orgdb_from_ahGet an orgdb from an AnnotationHub taxonID.
overlap_geneidsMostly as a reminder of how to get the gene IDs from a...
overlap_groupsExtract overlapping groups from an upset
parse_msigdbParse either xml or sqlite data from MSigDB. I think I will...
parse_msigdb_sqliteExtract metadata from the msigdb sqlite data.
parse_msigdb_xmlExtract fun experimental metadata from a MSigDB xml file.
pattern_count_genomeFind how many times a given pattern occurs in every gene of a...
pca_highscoresGet the highest/lowest scoring genes for every principle...
pca_informationGather information about principle components.
pct_all_keggExtract the percent differentially expressed genes for all...
pct_kegg_diffExtract the percent differentially expressed genes in a given...
pData-expt-methodA getter to pull the experimental metadata from an expt.
pData-set-expt-ANY-methodA setter to put the experimental metadata into an expt.
pData-set-SummarizedExperiment-ANY-methodA setter to put the experimental metadata into a...
pData-SummarizedExperiment-methodA getter to pull the experimental metadata from a...
pipePipe operator
please_installAutomatic loading and/or installing of packages.
plot_3d_pcaSomething silly for Najib.
plot_batchsvMake a dotplot of known batches vs. SVs.
plot_bcvSteal edgeR's plotBCV() and make it a ggplot2.
plot_boxplotMake a ggplot boxplot of a set of samples.
plot_cleavedPlot the average mass and expected intensity of a set of...
plot_corheatMake a heatmap.3 description of the correlation between...
plot_densityCreate a density plot, showing the distribution of each...
plot_de_pvalsGiven a DE table with p-values, plot them.
plot_disheatMake a heatmap.3 of the distances (euclidean by default)...
plot_dist_scatterMake a scatter plot between two sets of numbers with a cheesy...
plot_enrichresultInvoke ther various fun plots created by Guangchuang Yu.
plot_epitrochoidMake epitrochoid plots!
plot_essentialityPlot the essentiality of a library as per DeJesus et al.
plot_fun_vennA quick wrapper around venneuler to help label stuff
plot_goseq_pvalMake a pvalue plot from goseq data.
plot_gostats_pvalMake a pvalue plot similar to that from clusterprofiler from...
plot_gprofiler2_pvalMake a pvalue plot from gprofiler data.
plot_gprofiler_pvalMake a pvalue plot from gprofiler data.
plot_heatmapMake a heatmap.3 plot, does the work for plot_disheat and...
plot_heatmap-data.frame-methodRun plot_heatmap with a dataframe as input.
plot_heatmap-ExpressionSet-methodRun plot_heatmap with an ExpressionSet as input.
plot_heatmap-expt-methodRun plot_heatmap with an expt as input.
plot_heatmap-SummarizedExperiment-methodRun plot_heatmap with a SummarizedExperiment as input.
plot_heatplusPotential replacement for heatmap.2 based plots.
plot_histogramMake a pretty histogram of something.
plot_hypotrochoidMake hypotrochoid plots!
plot_intensity_mzPlot mzXML peak intensities with respect to m/z.
plot_legendScab the legend from a PCA plot and print it alone
plot_libsizeMake a ggplot graph of library sizes.
plot_libsize-data.frame-factor-character-methodRun plot_libsize() with a dataframe as input.
plot_libsize-ExpressionSet-ANY-ANY-methodRun plot_libsize() with an ExpressionSet as input.
plot_libsize-expt-ANY-ANY-methodRun plot_libsize() with an expt as input.
plot_libsize_prepostVisualize genes observed before/after filtering.
plot_libsize-SummarizedExperiment-ANY-ANY-methodSend a SummarizedExperiment to plot_libsize().
plot_linear_scatterMake a scatter plot between two groups with a linear model...
plot_lyPlotly for interactive 3-D plotting in the Shiny App
plotly_pcaPlot a PC plot with options suitable for ggplotly.
plot_ma_condition_deCreate a MA plot with colors from the original expressionset.
plot_ma_deMake a pretty MA plot from one of limma, deseq, edger, or...
plot_metadata_factorsProduce plots of metadata factor(s) of interest.
plot_meta_sankeyPlot metadata factors as a sankey diagram.
plot_meta_sankey-expt-methodFeed an expt to a sankey plot.
plot_multihistogramMake a pretty histogram of multiple datasets.
plot_multiplotMake a grid of plots.
plot_mzxml_boxplotMake a boxplot out of some of the various data available in...
plot_nonzeroMake a ggplot graph of the number of non-zero genes by...
plot_nonzero-ExpressionSet-methodMake a nonzero plot given an ExpressionSet
plot_nonzero-expt-methodMake a nonzero plot given an expt.
plot_nonzero-SummarizedExperiment-methodMake a nonzero plot given a SummarizedExperiment
plot_num_siggenesGiven a DE table with fold changes and p-values, show how...
plot_ontpvalMake a pvalue plot from a df of IDs, scores, and p-values.
plot_pairwise_maPlot all pairwise MA plots in an experiment.
plot_pcaMake a PCA plot describing the samples' clustering.
plot_pca_genesMake a PC plot describing the gene' clustering.
plot_pcfactormake a dotplot of some categorised factors and a set of...
plot_pcloadPrint a plot of the top-n most PC loaded genes.
plot_pcsPlot principle components and make them pretty.
plot_pct_keptMake a ggplot graph of the percentage/number of reads...
plot_peprophet_dataPlot some data from the result of extract_peprophet_data()
plot_pyprophet_countsCount some aspect(s) of the pyprophet data and plot them.
plot_pyprophet_distributionMake a boxplot out of some of the various data available in...
plot_pyprophet_pointsPlot some data from the result of extract_pyprophet_data()
plot_pyprophet_proteinRead data from pyprophet and plot columns from it.
plot_pyprophet_xyInvoked plot_pyprophet_counts() twice, once for the x-axis,...
plot_qq_allQuantile/quantile comparison of the mean of all samples vs....
plot_rmatsGiven some psi and tpm data from rMATS, make a pretty plot!
plot_rpmMake relatively pretty bar plots of coverage in a genome.
plot_sample_barsThe actual library size plotter.
plot_sample_cvheatmapAn experiment to see if I can visualize the genes with the...
plot_sample_heatmapMake a heatmap.3 description of the similarity of the genes...
plot_sample_heatmap-ExpressionSet-methodPlot a sample heatmap of an ExpressionSet.
plot_sample_heatmap-expt-methodPlot the sample heatmap of an expt.
plot_sample_heatmap-SummarizedExperiment-methodPlot a sample heatmap with a SummarizedExperiment.
plot_sankey_deMake a sankey plot showing how the number of genes deemed...
plot_scatterMake a pretty scatter plot between two sets of numbers.
plot_seurat_scatterMake a few of the likely scatterplots provided by...
plot_significant_barPlot significant genes by contrast with different colors for...
plot_single_qqPerform a qqplot between two columns of a matrix.
plot_smMake an R plot of the standard median correlation or distance...
plot_sm-data.frame-methodPlot the standard median pairwise values of a dataframe.
plot_sm-ExpressionSet-methodPlot the standard median pairwise values of an ExpressionSet.
plot_sm-expt-methodPlot the standard median pairwise values of an expt.
plot_sm-SummarizedExperiment-methodPlot the standard median pairwise values of a...
plot_spirographMake spirographs!
plot_suppaGiven some psi and tpm data, make a pretty plot!
plot_svfactorMake a dotplot of some categorised factors and a set of SVs...
plot_topgo_densitiesPlot the density of categories vs. the possibilities of all...
plot_topgo_pvalMake a pvalue plot from topgo data.
plot_topnPlot the representation of the top-n genes in the total...
plot_tsneShortcut to plot_pca(pc_method = "tsne")
plot_variance_coefficientsLook at the (biological)coefficient of variation/quartile...
plot_variance_coefficients-ExpressionSet-methodPlot the coefficient of variance values of an ExpressionSet.
plot_variance_coefficients-expt-methodPlot the coefficient of variance values of a...
plot_variance_coefficients-SummarizedExperiment-methodPlot the coefficient of variance values of a...
plot_volcano_condition_deTheresa's volcano plots are objectively nicer because they...
plot_volcano_deMake a pretty Volcano plot!
ppPlot a picture, with hopefully useful options for most(any)...
primer_qcPerform a series of tests of a putative primer.
print.abundant_genesPrint a summary of a set of abundant genes.
print.all_gprofilerPrint the result of all_gprofiler()
print.all_pairwisePrint function for a pairwise differential expression result.
print.annotations_biomartPrint function for a set of annotations downloaded from...
print.aucc_infoPrint the result from calculate_aucc().
print.biomart_goPrint the results of load_biomart_go().
print.cds_variant_primersPrint the results of snp_cds_primers().
print.classified_mutationsPrint the results of classify_snps().
print.classifier_evaluationPrint the result from self_evaluate_model().
print.clusterprofiler_resultPrint a clusterprofiler over representation search.
print.combined_dePrint a combined differential expression analysis.
print.combined_tablePrint a single combined DE result.
print.correlation_heatmapPrint the result of plot_corheat().
print.cross_table_comparisonPrint a representation of compare_de_tables(). Note I think I...
print.density_plotPrint the result from plot_density().
print.density_primersPrint a summary of putative PCR primers based on variant...
print.deseq_lrtPrint the result of running deseq_lrt().
print.distance_heatmapPrint the result of plot_disheat().
print.exptModified print function for an expt.
print.goseq_resultPrint a goseq over representation search.
print.gostats_resultPrint a gostats over representation search.
print.gprofiler_resultPrint a gprofiler over representation search.
print.graphed_metricsPrint a message about the results from graph_metrics().
print.gsva_resultPrint a gsva category search.
print.gsva_sigPrint gsva categories deemed 'significant'.
print.legend_plotPrint a legend of an expressionset.
print.libsize_plotPrint the library sizes from an experiment.
print.mapped_keepersPrint a set of mapped keepers from combine_de_tables()
print.meta_sankeyPrint a metadata sankey plot.
print.nonzero_plotPrint a nonzero plot.
print.partitioned_dataPrint something useful about the result of...
print.pattern_countedPrint some information about a pattern counted genome
print.pca_resultPrint the result from one of the various dimension...
print.prepost_filterPrint a representation of the pre vs. post filtered data.
print.preprocessing_metadataPrint the result from gather_preprocessing_metadata().
print.proper_estimatePrint the result from simple_proper().
print.reordered_varpartPrint the result of a reordered variance partition analysis.
print.sig_genesPrint some significantly differentially expressed genes.
print.sig_intersectPrint the intersection of significant genes from multiple...
print.snp_intersectionsPrint some information about the result of...
print.snp_setsPrint the result of get_snp_sets().
print.snps_genesPrint the result of snps_vs_genes().
print.standardmedian_plotPrint the result of plot_sm()
print.topgo_resultPrint a topgo over representation search.
print.topn_plotPrint a result from plot_topn().
print_ups_downsReprint the output from extract_significant_genes().
print.varcoef_plotPrint a result from plot_variance_coefficients().
print.varpartPrint variance partition results.
print.written_exptPrint the result from write_expt.
print.written_xlsxPrint the result from write_xlsx.
proportions_by_factorsExtract the proportions of each group/sample in a scd.
prune_networkExclude nodes from a network which are not well connected.
pull_git_commitReset the chosen git repository to a chosen commit.
random_ontologyPerform a simple_ontology() on some random data.
rank_order_scatterPlot the rank order of the data in two tables against each...
rbind_summary_rowsAppend rows containing summary() information.
read_counts_exptRead a bunch of count tables and create a usable data frame...
read_metadataGiven a table of meta data, read it in for use by...
read_snp_columnsRead the output from bcfutils into a count-table-esque
read_thermo_xlsxParse the difficult thermo fisher xlsx file.
recolor_pointsQuick point-recolorizer given an existing plot, df, list of...
record_seurat_samplesAdd into the miscellaneous SCD slot a dataframe with some...
rendermeAdd a little logic to rmarkdown::render to date the final...
replot_varpart_percentA shortcut for replotting the percent plots from...
rexSend the R plotter to the computer of your choice!
rowData-ExpressionSet-methodA getter of the gene information from an ExpressionSet,...
rowData-expt-methodA getter of the gene information from an expt, synonymous...
rowData-set-expt-methodA setter to put the gene information into an expt.
rowmax_filter_countsFilter low-count genes from a data set only using a simple...
rowMeansMake sure BiocGenerics' version of rowMeans is available.
s2s_all_filtersGather together the various SWATH2stats filters into one...
sampleNames-expt-methodA getter to get the samples names from an expt.
sampleNames-set-expt-ANY-methodA setter to put the samples names into an expt.
sampleNames-set-SummarizedExperiment-ANY-methodA setter to put the samples names into a...
sampleNames-SummarizedExperiment-methodA getter to get the samples names from a...
sanitize_exptGet rid of characters which will mess up contrast making and...
sanitize_expt_fDataGiven an expressionset, sanitize the gene information data.
sanitize_expt_pDataAdding an alias to sanitize_metadata until I decide how I...
sanitize_metadataGiven an expressionset, sanitize pData columns of interest.
sanitize_number_encodingRe-encode South American numbers so they fit my...
sanitize_percentSanitize unreliable presentation of percent values from...
savemeMake a backup rdata file for future reference
score_gsva_likelihoodsScore the results from simple_gsva().
score_mhessA scoring function for the mh_ess TNSeq method.
self_evaluate_modelCreate a confusion matrix and ROC of a model against its...
semantic_copynumber_extractExtract multicopy genes from up/down gene expression lists.
semantic_copynumber_filterRemove multicopy genes from up/down gene expression lists.
semantic_expt_filterRemove/keep specifically named genes from an expt.
sequence_attributesGather some simple sequence attributes.
sequential_variantsSearch a set of variants for ones which are relatively...
set_expt_batchesChange the batches of an expt.
set_expt_colorsChange the colors of an expt
set_expt_conditionsChange the condition of an expt
set_expt_factorsChange the factors (condition and batch) of an expt
set_expt_genename_columnSwitch the gene names of an expressionset using a column from...
set_expt_genenamesChange the gene names of an expt.
set_expt_samplenamesChange the sample names of an expt.
shinyShiny App for interactively visualizing RNAseq data
significant_barplotsGiven the set of significant genes from combine_de_tables(),...
sig_ontologiesTake the result from extract_significant_genes() and perform...
sillydistCalculate a simplistic distance function of a point against...
simple_clusterprofilerPerform the array of analyses in the 2016-04 version of...
simple_cp_enricherGeneric enrichment using clusterProfiler.
simple_dorotheaInvoke dorothea in an attempt to hunt down cool TFs.
simple_filter_countsFilter low-count genes from a data set only using a simple...
simple_gademrun the rGADEM suite
simple_goseqPerform a simplified goseq analysis.
simple_gostatsSimplification function for gostats, in the same vein as...
simple_gprofilerRedirect users to simple_gprofiler2
simple_gprofiler2Run searches against the web service g:Profiler.
simple_gprofiler_oldRun searches against the web service g:Profiler.
simple_gsvaProvide some defaults and guidance when attempting to use...
simple_motifRGRun motifRG on a fasta file.
simple_pathviewPrint some data onto KEGG pathways.
simple_properInvoke PROPER and replace its default data set with data of...
simple_topgoPerform a simplified topgo analysis.
simple_topgo-character-methodCoerce simple_topgo to accept a vector of gene IDs instead of...
simple_varpartUse variancePartition to try and understand where the...
simple_xcellInvoke xCell and pretty-ify the result.
single_topgo_treeCollapse the logic for collecting topgo trees into one little...
skim_seurat_metadataUse skimr to make pretty summaries of cell-data.
slide_de_thresholdmake a slideable threshold for cutting off significant genes...
smSilence
snp_by_chrThe real worker. This extracts positions for a single...
snp_cds_primersLook for variants associated with CDS regions instead of...
snp_density_primersCreate a density function given a variant output and some...
snpnames2grTake a vector of my peculiarly named variants and turn them...
snps_intersectionsCross reference observed variants against the transcriptome...
snp_subset_genesLook for only the variant positions in a subset of genes.
snps_vs_genesMake a summary of the observed snps by gene ID.
snps_vs_genes_paddedA copy of the above function with padding for species without...
stateGet the state of the data in an expt.
state-expt-methodExtract the state of an expt vis a vis normalization.
state-setSet the state of the data in an expt.
state-set-expt-methodPut the current state into an expt.
state-set-SummarizedExperiment-methodPut the state into a SummarizedExperiment.
state-SummarizedExperiment-methodGet the state from a SummarizedExperiment.
steal_salmon_tx_idsSteal transcript IDs from the first count table.
sub-.exptSubset an expt
subset_exptExtract a subset of samples following some rule(s) from an...
subset_expt-SummarizedExperiment-methodSubset a SummarizedExperiment with some extra syntax.
subset_genesExclude some genes given a pattern match
subset_ontology_searchPerform ontology searches on up/down subsets of differential...
sub-sub-expt-character-ANY-methodSimplifying subset on metadata.
subtract_exptTry a very literal subtraction
sum_eupath_exon_countsI want an easy way to sum counts in eupathdb-derived data...
sum_exon_widthsGiven a data frame of exon counts and annotation information,...
summarize_scd_clustersSummarize scores across observed clusters in a scd.
summarize_ups_downsCreate a summary table of the ranges of fold-change values of...
sva_modify_pvaluesUse sva's f.pvalue to adjust p-values for data adjusted by...
synchronize_exptSynchronize the extra elements of an expt with a new...
table_styleSet the xlsx table style
tar_meta_columnMake an archive using a column from the metadata.
tempfileA cheater redefinition of tempfile.
tmpmd5fileA hopefully more robust version of tempfile().
tnseq_multi_saturationPlot the saturation of multiple libraries simultaneously.
tnseq_saturationMake a plot and some simple numbers about tnseq saturation
topDiffGenesA very simple selector of strong scoring genes (by p-value)
topgo2enrichConvert a simple_topgo() result to an enrichResult.
topgo_tablesMake pretty tables out of topGO data
topgo_treesPrint trees from topGO.
transform_countsPerform a simple transformation of a count table (log2)
unAsIsRemove the AsIs attribute from some data structure.
u_plotPlot the rank order svd$u elements to get a view of how much...
upsetr_combined_deMake an upset plot of all up/down genes in a set of...
upsetr_sigUse UpSetR to compare significant gene lists.
variance_exptAdd some gene annotations based on the mean/variance in the...
varpart_summariesAttempt to use variancePartition's fitVarPartModel()...
verboseSet a default verbosity, for now this just queries if this is...
wgcna_networkJust putting down an example from Alejandro's work and...
what_happenedPrint a string describing what happened to this data.
write_basicWrites out the results of a basic search using...
write_cds_entriesExtract CDS sequences from a genome and set of annotations.
write_classifier_summaryWrite out the results of classify_n_times().
write_combined_legendWrite the legend of an excel file for combine_de_tables()
write_combined_summaryInternal function to write a summary of some combined data
write_cp_dataMake a pretty table of clusterprofiler data in excel.
write_density_primersWrite out a set of primers for testing.
write_deseqWrites out the results of a deseq search using...
write_de_tableWrites out the results of a single pairwise comparison.
write_edgerWrites out the results of a edger search using...
write_exptMake pretty xlsx files of count data.
write_goseq_dataMake a pretty table of goseq data in excel.
write_gostats_dataMake a pretty table of gostats data in excel.
write_go_xlsWrite gene ontology tables for excel
write_gprofiler_dataWrite some excel results from a gprofiler search.
write_gsvaWrite out my various attempts at making sense of gsva.
write_limmaWrites out the results of a limma search using...
write_sample_designPut the metadata at the end of combined_de_tables()
write_sig_legendInternal function to write a legend for significant gene...
write_snpsWrite a matrix of variants in an alignment-esque format.
write_subset_ontologiesWrite gene ontology tables for data subsets
write_suppa_tableTake a set of results from suppa and attempt to write it to a...
write_topgo_dataMake a pretty table of topgo data in excel.
write_xlsxWrite a dataframe to an excel spreadsheet sheet.
write_xlsx-ANY-ANY-ANY-written_xlsx-methodWrite an xlsx file given the result of an existing xlsx...
xlsx_insert_pngAn attempt to improve the behaivor of openxlsx's plot...
xref_regionsIf I were smart I would use an I/GRanges for this.
ymxb_printPrint a model as y = mx + b just like in grade school!
elsayed-lab/hpgltools documentation built on May 9, 2024, 5:02 a.m.