12,341 results • Page 31 of 206
are taken into account, which means essentially the heatmap was made by pair-wise correlation of vectors consist of 0 and 1. But in the new version (1.6.2) I found that the vectors get from peak sets contains also a number (rather...it uses the highest score). As you say, it then computes the correlation between each pair of vectors for the heatmap. Once you have run dba.count, it uses scores b…
Thanks. library(marrayInput) Monkey.info <- read.Galfile(galfile="Revised sethi-sh 136prg.gal") names(Monkey.info ) Monkey.info$layout Monkey.info$gnames > # create working dataset > datadir <- getwd() > fnames <- dir...1] "Reading ....gpr" Warning messages: 1: number of rows of result is not a multiple of vector length (arg 2) in: cbind(…
updated 22.5 years ago • White, Charles E WRAIR-Wash DC
geneList<-factor(as.integer(probekeys %in% intgenes) # intgenes= my list of interesting probeIDs names(geneList)<-probekeys str(geneList) Factor w/ 2 levels "0","1": 1 1 1 1 1 1 1 1 1 1 ... - attr(*, "names")= chr [1:33295] "7892501" "7892502" "7892503" "7892504...object ------------------------- test.stat <- new("classicCount", testStatistic = GOFisherTest, name = "Fisher t…
updated 12.7 years ago • Guest User
seqnames ranges strand | tx_id <rle> <iranges> <rle> | <character> [1] chr1 [ 12228, 12645] + | 1,2,3 [2] chr1 [ 12698, 13402] + | 1,2,3 [3] chr1 [322229, 324287] + | 7 [4] chr1 [324346, 324438] + | 7 [5] …
updated 12.4 years ago • Andrew Jaffe
use. ``` DataFrame with 6 rows and 6 columns fwd rev name class type <character> <character> <data.frame> <data.frame> <data.frame> 0h-rep1 /Users/matthew/mount.. /Users/matthew/mount...29 [123] memoise_2.0.1 ``` </data.frame></data.frame></data.f…
updated 4.1 years ago • matthew.valentine
Hi All, When I try to download GSE49656 with GEOquery, errors were always reported: such as __not all columns named in 'colClasses' exist__ &nbsp; When I change to server (linux), some other error reported: __Error in read.table(con, sep = "\\t", header...I try to download GSE49656 with GEOquery, errors were always reported: such as __not all columns named in 'colClasses' exist__ &nb…
updated 9.1 years ago • Shicheng Guo
exons, LungCancerBamFiles()) &gt; &gt; Yields: &gt; &gt; Note: method with signature 'GAlignments#Vector' chosen for function &gt; 'countOverlaps', &gt; target signature 'GAlignments#GRanges'. &gt; "Vector#GenomicRanges" would also...be valid &gt; Note: method with signature 'GAlignments#Vector' chosen for function &gt; 'countOverlaps', &gt; target si…
updated 12.6 years ago • Valerie Obenchain
methyLumiM) &gt;&gt; Error in apply(grnData[neg.ind, ], 2, median) : &gt;&gt; dim(X) must have a positive length &gt;&gt; &gt;&gt; &gt;&gt; I've tried to make sure that 'methyLumiM' has a controlData slot by the &gt;&gt; following...storageMode: lockedEnvironment) &gt;&gt; assayData: 14 features, 24 samples &gt;&gt; element names: …
Hello Günter, I noticed that '`` ExpLogFoldChange ``' in the function '`` .cn.mopsCE ``' (cn.mops.R) could either be a vector or a matrix with one row as noted in the code snippet below. &nbsp; <pre> &nbsp;&nbsp; &nbsp;if (all(x&lt;=minReadCount)) { &nbsp;&nbsp; &nbsp;&nbsp;&nbsp; &nbsp;[...] &nbsp;&nbsp; &nbsp;&nbsp;&nbs…
updated 9.2 years ago • Mohammad Alkhamis
Hi all, I am running WGCNA on my big gene expression data set, and running into a bunch of errors. I appreciate any help in advance that you can provide in navigating these! First, the graph generated to choose the power is wacky looking. ![here it is][1] I chose 28, as I figured this was above the threshold. But is that elbow cause for concern? Second, going forward with a power of 28, altho…
updated 2.1 years ago • aehall26
<div class="preformatted">Hi, I have been looking around at examples of the hyperGTest (in the GOstats, lumi, and other documentation) and feel like I have seen many slight variations on the methodology. These variations are usually found in the way the non-specific filtering is performed. I haven't come across many examples of a hyperGTest for KEGG pathways and would like to ask whether my…
updated 17.3 years ago • Sebastien Gerega
the results of unit testing. I use the following in my ~/.Makefile to see these results imidiately NAME := $(shell basename $(PWD)) # Get current map name Rcheck: # Check R package of current map (cd ..; \ R CMD check $(NAME) &amp;&amp; \ if [ -d $(NAME)/inst/unitTests...then \ cat $(NAME).Rcheck/tests/doRUnit.Rout; \ fi) Then only the followin…
updated 19.4 years ago • Gorjanc Gregor
I type the columns in the data.frame and get a little further as(data.frame(SeqID=character(),start=integer(),end=integer()),'GRanges') Error in validObject(.Object) : invalid class "GRanges" object: NROW(strand(x)) != length...x) Almost across the line. Let's add the strand in too: &gt; as(data.frame(SeqID=character(),start=integer(),end=integer(),strand=…
updated 7.9 years ago • Malcolm Cook
error: ``` The query to the BioMart webservice returned an invalid result: biomaRt expected a character string of length 1. Please report this on the support site at http://support.bioconductor.org ``` Here is an example...sets (returns list of two ExpressionSets) gset_ls &lt;- getGEO("GSE4922", GSEMatrix = T, getGPL = F) names(gset_ls) [1] "GSE4922-GPL96_series_matrix.txt.gz…
updated 6.6 years ago • wes
pheno parameter contains more than 2 phenotypes, and you want to use ProbeLasso function, you MUST specify compare.group=c("A","B"). Bumphunter and DMRcate should not be influenced. [ Section 1: Check Input Pheno Start ] You pheno...No rownamematches. 'rownames' need to match IlluminaHumanMethylation450k probe names. The same error happens when arraytype="EPIC"…
updated 12 months ago • André
the order of the cols and rows is the same data &lt;- data[, row.names(metadata)] # The data must be un-logged data &lt;- round((2 ** data) -1) DESeq2::DESeqDataSetFromMatrix( data, metadata, ~ status ) |&gt; DESeq2::DESeq() -&gt; dsq_obj DESeq2...results(dsq_obj, name = "status_case_vs_control") -&gt; dsq_res cat("Deseq finished running!…
updated 2.2 years ago • Luca
lt;- makeContrasts(-2,2-3,3-4,4-5,5-6,6,levels=design) HOWEVER, to make this work the column names of the your design matrix must start with a letter, not a number. E.g., you need "Time2", "Time3" etc instead of "2", "3" etc. &gt; I know there
updated 18.8 years ago • Gordon Smyth
lt;-rma(howard1.raw) I get the following errormessage: Error in hist.default(howard1.norm) : `x' must be numeric Jim MacDonald pointed out to me that a file made with the command &gt; dat1 &lt;- normalize.AffyBatch.quantiles...Isaac Friedman, age 14 -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: text/enriched Size: 1732 bytes De…
updated 21.7 years ago • Richard Friedman
<div class="preformatted"> Iam using R version 2.15 in a linux operating system. I have a matrix consisting of the gene ids and their specific signal intensity values as follows( a subset of the whole matrix) : probes GSM362180 GSM362181 GSM362188 GSM362189 GSM362192 244901 5.094871713 4.626623079 4.554272515 4.748604391 4.759221647 244902 5.194528083 4.985930299 4.…
updated 13.2 years ago • Guest User
<div class="preformatted"> &gt;But when I try the widget option I still get: &gt; &gt;&gt; alldata &lt;- ReadAffy(widget=TRUE) &gt;Error in structure(.External("dotTcl", ..., PACKAGE = "tcltk"), class = &gt;"tclObj") : &gt; [tcl] ambiguous option "-col": must be -column, -columnspan, &gt;-in, -ipadx, -ipady, -padx, -pady, -row, -rowspan, or -sticky…
updated 22.6 years ago • John Zhang
Min. : 5.96 Min. :-6.2495 Min. :0.1065 Min. :-5.9385 Min. :2.900e-09 Class :character 1st Qu.: 61.23 1st Qu.:-1.7460 1st Qu.:0.1518 1st Qu.:-3.8379 1st Qu.:2.666e-05 Mode :character Median : 281.04 Median :-0.5681...SYMBOL Min. :2.121e-05 Length:172 1st Qu.:9.582e-03 Class :character Median :2.859e-02 Mode :character…
updated 2.7 years ago • akrunic
if this is a source package ... OK * checking package directory ... OK * checking for portable file names ... OK * checking package dependencies ... OK * checking index information ... OK * checking package subdirectories ... OK * checking...halted In R, the argument of a replacement function which corresponds to the right hand side must be named 'value'. * checking foreign function calls ... WAR…
updated 20.6 years ago • michael watson IAH-C
<div class="preformatted"> maInd2Coord cannot index a single gene, or vector of length 1. &gt; L &lt;- new("marrayLayout", maNgr = 4, maNgc = 4, maNsr = 22, maNsc = 24) # Index to Coord fails for vector of length 1 (scalar) &gt; maInd2Coord(5, L) Error in "colnames&lt;-"(`*tmp*`, value = c("Grid.R", "Grid.C", "Spot.R", : attempt to set colnames on object with less…
updated 20.7 years ago • Marcus Davy
if (sum(!gsg$goodGenes)&gt;0) printFlush(paste("Removing genes:", paste(names(GE.adjusted)[!gsg$goodGenes], collapse = ", "))); if (sum(!gsg$goodSamples)&gt;0) printFlush(paste("Removing samples:", paste(rownames...par(mar = c(6, 8.5, 3, 3)); labeledHeatmap(Matrix = moduleTraitCor, xLabels = names(datTraits), yLabels = …
updated 5.5 years ago • zen
gt; &gt; &gt; makeGRangesFromRefSNPids &lt;- function(myids) &gt; + { &gt; + ans_seqnames &lt;- character(length(myids)) &gt; + ans_seqnames[] &lt;- "unknown" &gt; + ans_locs &lt;- integer(length(myids)) &gt; + for (seqname in names(getSNPcount...gt; &gt; &gt; makeGRangesFromRefSNPids &lt;- function(myids) &gt; + { &a…
package. After all steps, approximately 3% of LRR and 2% of BAF values turned into NA. What exactly must be the interpretation for those NA values?&nbsp;Must I assume a lack of signal or hybridization (just noise) for NA values
updated 10.1 years ago • Vinicius Henrique da Silva
hi, Does someone know how to created matrices using rsruby? I have problems trying to put 2 ruby vectors in a R matrix. I already read the links on rsruby feeds, what I needs is working examples. I want to create boxplots and...plots with matrices. I have succeeded to do it with vectors. Thanks you very much. </div
updated 16.4 years ago • D.Enrique ESCOBAR ESPINOZA
code (the last statement) does not work and give the error of 'Error in shell.exec(url) : file name conversion problem' #=========== browserSession()-&gt;toto ucscTrackModes(toto)-&gt;togai tracks(toto)-&gt;toto2 tracks(togai)&lt;-sample
updated 17.2 years ago • li lilingdu
1' count = '0' datasetConfigVersion = '0.6' header='0' requestid= 'biomaRt'&gt; &lt;Dataset name = 'hsapiens_gene_ensembl'&gt;&lt;Attribute name = 'ensembl_gene_id'/&gt;&lt;Attribute name = 'mim_morbid_description'/&gt;&lt;Filter...name = 'hgnc_symbol' value = 'brca2,lct' /&gt;&lt;/Dataset&gt;&lt;/Query&gt; ################# Results from serve…
updated 10.9 years ago • Tibor Fulop
when running celltree: <pre> Error in apply(dists[backbone, -backbone], 2, which.min) : dim(X) must have a positive length</pre> This can be fixed by adding a drop=F such that: <pre> Error in apply(dists[backbone, -backbone, drop...F], 2, which.min) : dim(X) must have a positive length</pre
updated 8.4 years ago • wouter.saelens
div class="preformatted">Dear group: I have a vector of gene symbols. I want to get EntrezID for those gene symbols. I want to use hgu133plus2 as my annotation environment...how can I do it. here is my vector: msba &lt;- c('AURKA','CCNB2','TRIP13','EZH2','TYMS') when I have probesetid it is straightforward for me. thanks for your help. srini
updated 17.8 years ago • Srinivas Iyyer
error is: "Error in graph.adjacency.dense(adjmatrix, mode = mode, weighted = weighted, : long vectors not supported yet: ../../src/include/Rinlinedfuns.h:519" The code i use is showed below: library(dplyr) library(Seurat) library...this row is to decide the distribution of data #look at the cell data and change the name of upstream cluster information head(pData(monocle)) names(pD…
updated 6.4 years ago • 444579004
using "new" I then want to generate a dist object &gt; dd = dist(exprs(exampleSet)) Error in vector("double", length) : cannot allocate vector of length 582309001 or &gt; dd = dist(exampleSet) Error in vector("double", length) : cannot...allocate vector of length 582309001 It is probable I need to reduce the data set first as most genes are not differentially expressed
updated 14.7 years ago • john herbert
Iris.CEL" "Liv1.CEL" "Liv2.CEL" "Liv3.CEL" &gt; AF_data = read.celfiles(celFiles) All the CEL files must be of the same type. Error: checkChipTypes(filenames, verbose, "affymetrix", TRUE) is not TRUE Then I tried reading files separately...Liv3.CEL" &gt; AF_data = read.celfiles(celFiles,pkgname='pd.huex.1.0.st.v2') All the CEL files must be of the same type. Error: checkChipTypes(filen…
updated 12.4 years ago • Bade
call)) : error in evaluating the argument 'x' in selecting a method for function 'as.matrix': 'file' must be a character string or connection # please also include the results of running the following in an R session ![this is how
updated 3.4 years ago • sumitra
x, row.names=colnames(filtered))) Error in data.frame(x, row.names = colnames(filtered)) : row names supplied are of the wrong length ``` Anyone could give me a hint on why this is wrong? Thanks in advance Cecilia ``` &gt; sessionInfo
updated 6.6 years ago • ce.jim.san
p/184091/).) I'm stumped. I'm trying to plot a few transcripts at the same time, given transcript names and a TxDb. These are examples of approaches I've tried: <pre> # ------------------------------------------------------------------------------ # Setup: library(TxDb.Hsapiens.UCSC.hg19.knownGene) library
updated 9.8 years ago • stianlagstad
lt;- read.delim("normalizedData.txt",sep ="\t") ######### two class unpaired comparison # y must take values 1,2 classes &lt;- c(-1,-2,1,2) #prepere the data for the samr analysis data.x &lt;-as.matrix(normData[,8:11]) d=list(x=data.x...attr(*, "dimnames")=List of 2 .. ..$ : NULL .. ..$ : chr [1:8] "Row" "Gene ID" "Gene Name" "Score(d)" ... $ genes.lo : chr [1:10788,…
updated 14.9 years ago • Assa Yeroslaviz
Hi, I just reinstalled TxDb.Hsapiens.UCSC.hg19.knownGene and it does not function. When I load the package, the TxDb object looks fine, but applying any function to it fails.&nbsp; For example genes() gives character(0) and seqlevels() gives an empty GRanges object: &nbsp; &nbsp; <pre> &gt; library(TxDb.Hsapiens.UCSC.hg19.knownGene) &gt...the TxDb object looks fine, …
updated 8.3 years ago • l.selfors
Hi, &nbsp; After doing DESeq2 with RNA seq data, the output I obtain is an excel file with ensembl transcript ID, baseMean, log2FoldChange, lfcSE, stat, pvalue, and padj. I would like to know 2 things: -If you know if there is any code that I can use in order to obtain the gene name or description in the output file instead of the ensembl transcript ID -If there is any code to obtain mor…
updated 10.2 years ago • amyfm
Ct values, already averaged over the technical repeats. I also have a header indicating the gene names (so i set _header=true_). I load my text tab separated matrix with _read.delim_ and then i use _readCtData_ like this: <pre...code>Error in data.frame(sample = 1:length(samples), row.names = samples) :&nbsp;<br/> &nbsp; row names supplied are of the wrong length</code&…
updated 9.7 years ago • virginia.claudio
mtable) : unable to find an inherited method for function "GeneSetCollection", for signature "character", "character", "KEGGCollection" How can I build my Gene set object? Thanks, Javier </div
updated 16.1 years ago • Javier Pérez Florido
gt; showMethods(computeExprSet) $ Function "computeExprSet": $ x = "AffyBatch", pmcorrect.method = "character", summary.method = "character" $&gt; and afterwards I tried to retrieve the code with $&gt; getMethod("computeExprSet", "AffyBatch
updated 20.1 years ago • Benjamin Otto
have some difficulties in performing the cViz command. I get an error telling me that my data object must me atomic, but is.atmoic insists that the object is indeed atmoic. Yourdata is the example data on the homepage of ChromoViz...cViz(yourdata, cytoBand9606) #Error in sort(unique.default(x), na.last = TRUE) : # `x' must be atomic is.atomic(yourdata) # [1] FALSE yourdata2&lt;-as.matr…
updated 20.6 years ago • Morten
p-values. The normalized expression values are in the 22283-by-16 matrix expr. The 16-long dclass vector contains the classifiers [0 1 0 1 0 1 0 ...] The goal is to compute the 22283-long vector with the adjusted p-values. Does any one
updated 22.1 years ago • Kevin Dawson
<div class="preformatted">Hi Alexander, see below for some comments. I also CCed the Bioconductor list so others can benefit from it, too. -- From: Alexander Kanitz <alexander.kanitz@unibas.ch<mailto:alexander.kanitz@unibas.ch>&gt; Date: Tuesday, March 19, 2013 6:09 PM To: NIBR <florian.hahne@novartis.com<mailto:florian.hahne@novartis.com>&gt; Subject: Fragen zu G…
updated 12.8 years ago • florian.hahne@novartis.com
<div class="preformatted">Hi, all I am trying to use goseq for RNAseq data analysis of a non-native bacteria, I fetch the genelength data and GO term data by using ensembl Perl API. Differential expression was done by DESeq2. After data run pwf of goseq, error occurred as following: ### Error in if (hi &lt;= low) { : missing value where TRUE/FALSE needed Have any one met this befor…
<div class="preformatted">Dear list, For the GAGE analysis, i am getting an error shown below. Error in rank(cns) : unimplemented type 'NULL' in 'greater' In addition: Warning message: In is.na(x) : is.na() applied to non-(list or vector) of type 'NULL' I got the gene sets, expression data and reference and target files ready for it and it seems that files are...type 'NULL' in 'greater' In…
updated 13.9 years ago • Javerjung Sandhu
I want to obtain all human homologous gene from a Ensembl.Gene.ID vector of all Mouse genes. The df i obtain is missing many entries. Also if I use gene names instead of the Ensemble ID I have the
updated 9.2 years ago • alessandro.pastore
each row is one affy probe and each column is from one array. ## the second argument ?diagno? is a vector containing 10 group names (?treated? or ?control?) for the 10 arrays and they are in the corresponding order to the 10 columns
updated 19.3 years ago • mike Ad.
which worked well in the paper: ``` #Error in makeTxDbFromGFF(gtffile, format = "gtf", circ_seqs = character()) : could not find function "makeTxDbFromGFF" Please how do I solve it? &gt; bamfiles &lt;- BamFileList(filenames, yieldSize...gt; (txdb &lt;- makeTxDbFromGFF(gtffile, format="gtf", circ_seqs=character())) # Error in makeTxDbFromGFF(gtffile, format = "gtf", circ_seqs = char…
updated 2.5 years ago • ikpa_p123
Hi, I am using SGSeq and have a problem with the analyzefeatures function. Below, I have provided my code and my problems. Could you please kindly guide me? ```r library(SGSeq) library(TxDb.Hsapiens.UCSC.hg38.knownGene) library(GenomicRanges) # Define the path to your BAM files bam_path &lt;- "the path of my bam files" (ps: I have 41 bam files) # List the BAM files in the directory b…
updated 21 months ago • Sara
I'm going to be using frmatools to generate experiment-specific fRMA vectors from a set of training data, and these vectors will be used to normalize that training data as well as individual samples...independently, but I wonder if it makes sense to pool them for the purpose of generating the fRMA vectors. Pooling would obviously result in one set of vectors based on a larger dataset, and therefo…
updated 10.9 years ago • Ryan C. Thompson
So the RG object wouldn't get created and nothing was loaded. I tried saving the files under new names and trying again. I checked that everything was tab-delimited text. No luck. I also tested the files by loading them using...the older version of limmaGUI (v1.0.2) and they loaded no problem. So the files themselves must be fine. It's really quite strange. Has anyone had a problem similar to t…
updated 21.5 years ago • Elva Diaz
but the pSize and NDE are always equal for every pathway evaluated - the top 10 are listed below. Name ID pSize NDE tA pNDE pPERT 1 Cytokine-cytokine receptor int 04060 44 44 17.81364905 1 0.000005 2 Chemokine signaling...05332 12 12 17.…
I have an AAStringSet containing the name and sequences of proteins of interest. ![Image of the stringset][1] I am trying to find from this set, hom many patterns match...EDVF or EEVF. I've try to do this but only get error codes in return saying that it needs to be a vector and not an AAstringset Object. ```r pattern &lt;- c("DDVF", "DEVF", "EDVF", "EEVF") # str_detect(string = prot…
updated 13 months ago • Cédric
should get 1.6.4, which is the current vesrion on the devel arm. &gt; &gt; &gt; GOLocmap&lt;-mget(names(myGOCC$intCounts),GOALLLOCUSID); &gt; Error in mget(names(myGOCC$intCounts), GOALLLOCUSID) : &gt; Object "GOALLLOCUSID" not found...gt; This will be fine for almost all users &gt; &gt; Error in match(pkgs, libPkgs) : match requires vector arguments …
updated 21.2 years ago • rgentleman
<div class="preformatted">Hi All, Sorry to trouble everyone but I didn't get my subsetting of an RGList sorted last week. I've tried loads of different combinations of things that were suggested but not quite there yet. MY Data is an RGList object here is a bit &gt; R[1,1] An object of class "RGList" $G C:\\Program Files\\Agilent\\GeneSpring GX\\data\\CRX\\980\\test01_25148502098…
updated 18.2 years ago • elliot harrison
Dear List, could anybody help on how to insert columns in TopTable for entrez gene id, gene name and symbol when using the hugene1.0ST arrays. When using the regular 3'IVT arrays such as the hgu133plus2 I used the following
updated 15.1 years ago • Marcos Pinho
I have gene file in this format, everything in one column (no spaces at all): SFTPB|NM_000542.1|4506904|surfactant, pulmonary-associated protein B Is there any way to convert it in this format (into four columns) except manually? SFTPB NM_000542.1 4506904 surfactant, pulmonary-associated protein B Any suggestions? Narendra Dr. Narendra Kaushik School of Bi…
updated 20.2 years ago • Narendra Kaushik
12,341 results • Page 31 of 206
Traffic: 1172 users visited in the last hour
Help About
FAQ
Access RSS
API
Stats

Use of this site constitutes acceptance of our User Agreement and Privacy Policy.

Powered by the version 2.3.6