Uses of Class
ubic.gemma.model.genome.Gene
Packages that use Gene
Package
Description
This package contains I/O utilities for reading and writing expression data matrices.
Utilities for mapping
Identifiable entities to external identifiers.This package contains classes related to the Cell Browser visualization tool.
-
Uses of Gene in ubic.gemma.core.analysis.expression.coexpression.links
Methods in ubic.gemma.core.analysis.expression.coexpression.links that return types with arguments of type GeneModifier and TypeMethodDescriptionLinkAnalysis.getGenesTested()Gene the genes that were tested, according to the rows that are currently in the dataMatrix (so call this after filtering!)LinkAnalysis.getProbeToGeneMap()Method parameters in ubic.gemma.core.analysis.expression.coexpression.links with type arguments of type GeneModifier and TypeMethodDescriptionvoidAbstractMatrixRowPairAnalysis.setDuplicateMap(Map<CompositeSequence, Set<Gene>> probeToGeneMap) voidMatrixRowPairAnalysis.setDuplicateMap(Map<CompositeSequence, Set<Gene>> probeToGeneMap) voidLinkAnalysis.setProbeToGeneMap(Map<CompositeSequence, Set<Gene>> probeToGeneMap) Once set, is unmodifiable. -
Uses of Gene in ubic.gemma.core.analysis.expression.diff
Methods in ubic.gemma.core.analysis.expression.diff with parameters of type GeneModifier and TypeMethodDescriptionGeneDifferentialExpressionService.getDifferentialExpression(Gene gene, double threshold, int limit) Get the differential expression results for the given gene across all datasets.GeneDifferentialExpressionService.getDifferentialExpression(Gene gene, double threshold, Collection<DiffExpressionSelectedFactorCommand> factorMap) Get differential expression for a gene, constrained to a specific set of factors.GeneDifferentialExpressionService.getDifferentialExpression(Gene gene, Collection<BioAssaySet> experimentsAnalyzed, boolean includeSubSets) Get the differential expression results for the given gene that is in a specified set of experiments.GeneDifferentialExpressionService.getDifferentialExpression(Gene gene, BioAssaySet experimentAnalyzed, boolean includeSubSets, double threshold, int limit) Get the differential expression results for the given gene that is in a specified set of experiments.GeneDifferentialExpressionServiceImpl.getDifferentialExpression(Gene gene, double threshold, int limit) GeneDifferentialExpressionServiceImpl.getDifferentialExpression(Gene gene, double threshold, Collection<DiffExpressionSelectedFactorCommand> factorMap) GeneDifferentialExpressionServiceImpl.getDifferentialExpression(Gene gene, Collection<BioAssaySet> experimentsAnalyzed, boolean includeSubSets) GeneDifferentialExpressionServiceImpl.getDifferentialExpression(Gene gene, BioAssaySet experimentAnalyzed, boolean includeSubSets, double threshold, int limit) GeneDifferentialExpressionService.getDifferentialExpressionMetaAnalysis(double threshold, Gene g, Map<Long, Long> eeFactorsMap, Collection<BioAssaySet> activeExperiments, boolean includeSubSets) Get the differential expression analysis results for the gene in the activeExperiments.GeneDifferentialExpressionServiceImpl.getDifferentialExpressionMetaAnalysis(double threshold, Gene g, Map<Long, Long> eeFactorsMap, Collection<BioAssaySet> experimentsAnalyzed, boolean includeSubSets) -
Uses of Gene in ubic.gemma.core.analysis.sequence
Methods in ubic.gemma.core.analysis.sequence that return types with arguments of type GeneMethods in ubic.gemma.core.analysis.sequence with parameters of type GeneModifier and TypeMethodDescriptionstatic intSequenceManipulation.getGeneExonOverlaps(String chromosome, String starts, String sizes, String strand, Gene gene) Given a gene, find out how much of it overlaps with exons provided as starts and sizes.Method parameters in ubic.gemma.core.analysis.sequence with type arguments of type GeneModifier and TypeMethodDescriptionvoidCompositeSequenceMapSummary.setGenes(Collection<Gene> genes) -
Uses of Gene in ubic.gemma.core.analysis.service
Methods in ubic.gemma.core.analysis.service that return types with arguments of type GeneModifier and TypeMethodDescriptionCompositeSequenceGeneMapperService.getGene2ProbeMapByOfficialSymbols(Collection<String> officialSymbols, Collection<ArrayDesign> arrayDesigns) ExpressionDataMatrixService.getRankMatrix(Collection<Gene> genes, Collection<ExpressionExperiment> ees, ProcessedExpressionDataVectorDao.RankMethod method) ExpressionDataMatrixServiceImpl.getRankMatrix(Collection<Gene> genes, Collection<ExpressionExperiment> ees, ProcessedExpressionDataVectorDao.RankMethod method) Methods in ubic.gemma.core.analysis.service with parameters of type GeneModifier and TypeMethodDescriptionvoidDifferentialExpressionAnalysisResultListFileService.writeTsv(List<DifferentialExpressionAnalysisResult> payload, Gene gene, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, Writer writer) Writes a list of DE results with additional columns for mapping them to source experiments and analyzed experiments (for subsets).voidDifferentialExpressionAnalysisResultListFileServiceImpl.writeTsv(List<DifferentialExpressionAnalysisResult> entity, Gene gene, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, Writer writer) Method parameters in ubic.gemma.core.analysis.service with type arguments of type GeneModifier and TypeMethodDescriptionintArrayDesignAnnotationService.generateAnnotationFile(Writer writer, Collection<Gene> genes, Boolean useGO) Generate an annotation for a list of genes, instead of probes.intArrayDesignAnnotationServiceImpl.generateAnnotationFile(Writer writer, Collection<Gene> genes, Boolean useGO) ExpressionDataMatrixService.getRankMatrix(Collection<Gene> genes, Collection<ExpressionExperiment> ees, ProcessedExpressionDataVectorDao.RankMethod method) ExpressionDataMatrixServiceImpl.getRankMatrix(Collection<Gene> genes, Collection<ExpressionExperiment> ees, ProcessedExpressionDataVectorDao.RankMethod method) voidExpressionAnalysisResultSetFileService.writeTsv(ExpressionAnalysisResultSet analysisResultSet, Baseline baseline, Map<Long, Set<Gene>> result2Genes, Writer writer) Write the analysis result set with result-to-gene mappings.voidExpressionAnalysisResultSetFileServiceImpl.writeTsv(ExpressionAnalysisResultSet analysisResultSet, Baseline baseline, Map<Long, Set<Gene>> resultId2Genes, Writer writer) -
Uses of Gene in ubic.gemma.core.datastructure.matrix.io
Method parameters in ubic.gemma.core.datastructure.matrix.io with type arguments of type GeneModifier and TypeMethodDescriptionintMatrixWriter.write(BulkExpressionDataMatrix<?> matrix, Class<? extends BulkExpressionDataVector> vectorType, Map<CompositeSequence, Collection<Gene>> geneAnnotations, Writer writer) intMexMatrixWriter.write(SingleCellExpressionDataMatrix<?> matrix, Map<CompositeSequence, Set<Gene>> cs2gene, OutputStream stream) Write a MEX matrix as a TAR archive to the given output stream.intMexMatrixWriter.write(SingleCellExpressionDataMatrix<?> matrix, Map<CompositeSequence, Set<Gene>> cs2gene, Path outputDir) Write a matrix to a directory.intTabularMatrixWriter.write(Collection<SingleCellExpressionDataVector> vectors, Map<CompositeSequence, Set<Gene>> cs2gene, Writer writer) intTabularMatrixWriter.write(Stream<SingleCellExpressionDataVector> vectors, Map<CompositeSequence, Set<Gene>> cs2gene, Writer writer) intTabularMatrixWriter.write(SingleCellExpressionDataMatrix<?> matrix, Map<CompositeSequence, Set<Gene>> cs2gene, Writer writer) -
Uses of Gene in ubic.gemma.core.goldenpath
Methods in ubic.gemma.core.goldenpath that return GeneModifier and TypeMethodDescriptionGoldenPathSequenceAnalysis.findClosestGene(String chromosome, Long queryStart, Long queryEnd, String strand, int maxWindow) Given a location, find the nearest gene on the same strand, including only "known", "refseq" or "ensembl" transcripts.Methods in ubic.gemma.core.goldenpath that return types with arguments of type GeneModifier and TypeMethodDescriptionGoldenPathSequenceAnalysis.findESTs(String chromosome, Long regionStart, Long regionEnd, String strand) Check to see if there are ESTs that overlap with this region.GoldenPathSequenceAnalysis.findRNAs(String chromosome, Long regionStart, Long regionEnd, String strand) Check to see if there are mRNAs that overlap with this region. -
Uses of Gene in ubic.gemma.core.loader.genome.gene.ncbi
Methods in ubic.gemma.core.loader.genome.gene.ncbi that return GeneModifier and TypeMethodDescriptionNcbiGeneConverter.convert(NCBIGeneInfo info) NcbiGeneConverter.convert(NcbiGeneData data) Methods in ubic.gemma.core.loader.genome.gene.ncbi with parameters of type Gene -
Uses of Gene in ubic.gemma.core.loader.genome.gene.ncbi.homology
Methods in ubic.gemma.core.loader.genome.gene.ncbi.homology that return GeneModifier and TypeMethodDescriptionHomologeneService.getHomologue(Gene gene, Taxon taxon) HomologeneServiceImpl.getHomologue(Gene gene, Taxon taxon) Methods in ubic.gemma.core.loader.genome.gene.ncbi.homology that return types with arguments of type GeneModifier and TypeMethodDescriptionHomologeneService.getHomologues(Gene gene) HomologeneServiceImpl.getHomologues(Gene gene) Methods in ubic.gemma.core.loader.genome.gene.ncbi.homology with parameters of type GeneModifier and TypeMethodDescriptionHomologeneService.getHomologue(Gene gene, Taxon taxon) HomologeneServiceImpl.getHomologue(Gene gene, Taxon taxon) HomologeneService.getHomologues(Gene gene) HomologeneServiceImpl.getHomologues(Gene gene) -
Uses of Gene in ubic.gemma.core.loader.util.mapper
Methods in ubic.gemma.core.loader.util.mapper with parameters of type GeneModifier and TypeMethodDescriptionprotected abstract KAbstractGeneIdentifierBasedDesignElementMapper.getIdentifier(Gene gene) Extract an identifier from the gene.protected StringEnsemblIdDesignElementMapper.getIdentifier(Gene gene) protected StringGeneNameDesignElementMapper.getIdentifier(Gene gene) protected IntegerNcbiIdDesignElementMapper.getIdentifier(Gene gene) protected StringOfficialSymbolDesignElementMapper.getIdentifier(Gene gene) Constructor parameters in ubic.gemma.core.loader.util.mapper with type arguments of type GeneModifierConstructorDescriptionprotected -
Uses of Gene in ubic.gemma.core.ontology
Methods in ubic.gemma.core.ontology with parameters of type GeneModifier and TypeMethodDescriptionGoMetric.computeMatrixSimilarity(Gene gene1, Gene gene2, DoubleMatrix<Long, String> gene2TermMatrix, GoMetric.Metric metric) GoMetricImpl.computeMatrixSimilarity(Gene gene1, Gene gene2, DoubleMatrix<Long, String> gene2TermMatrix, GoMetric.Metric metric) GoMetric.computeMaxSimilarity(Gene queryGene, Gene targetGene, Map<String, Double> GOProbMap, GoMetric.Metric metric) GoMetricImpl.computeMaxSimilarity(Gene queryGene, Gene targetGene, Map<String, Double> GOProbMap, GoMetric.Metric metric) GoMetric.computeSimilarity(Gene queryGene, Gene targetGene, Map<String, Double> GOProbMap, GoMetric.Metric metric) GoMetricImpl.computeSimilarity(Gene queryGene, Gene targetGene, Map<String, Double> GOProbMap, GoMetric.Metric metric) GoMetric.computeSimpleOverlap(Gene g, Gene coexpG, Map<Long, Collection<String>> geneGoMap) GoMetricImpl.computeSimpleOverlap(Gene g, Gene coexpG, Map<Long, Collection<String>> geneGoMap) Method parameters in ubic.gemma.core.ontology with type arguments of type GeneModifier and TypeMethodDescriptionGoMetric.computeMergedOverlap(List<Gene> sameGenes1, List<Gene> sameGenes2, Map<Long, Collection<String>> geneGoMap) GoMetricImpl.computeMergedOverlap(List<Gene> sameGenes1, List<Gene> sameGenes2, Map<Long, Collection<String>> geneGoMap) Tailored to handle computing overlap between two gene lists which may contain duplicate genes of the same name but different IDs. -
Uses of Gene in ubic.gemma.core.ontology.providers
Methods in ubic.gemma.core.ontology.providers that return types with arguments of type GeneModifier and TypeMethodDescriptionFind genes for a given GO term by GO ID.GeneOntologyService.getGenes(OntologyTerm goTerm, Taxon taxon) Find genes for a given of GO term.GeneOntologyServiceImpl.getGenes(OntologyTerm term, Taxon taxon) Methods in ubic.gemma.core.ontology.providers with parameters of type GeneModifier and TypeMethodDescriptionGeneOntologyService.calculateGoTermOverlap(Gene queryGene, Collection<Long> geneIds) Given a query Gene, and a collection of gene ids calculates the go term overlap for each pair of queryGene and gene in the given collection.GeneOntologyService.calculateGoTermOverlap(Gene queryGene1, Gene queryGene2) GeneOntologyServiceImpl.calculateGoTermOverlap(Gene queryGene, Collection<Long> geneIds) GeneOntologyServiceImpl.calculateGoTermOverlap(Gene queryGene1, Gene queryGene2) GeneOntologyService.getGOTerms(Gene gene) GeneOntologyService.getGOTerms(Gene gene, boolean includePartOf, GeneOntologyServiceImpl.GOAspect goAspect) Get all GO terms for a gene, including parents of terms via is-a relationships; and optionally also parents via part-of relationships.GeneOntologyServiceImpl.getGOTerms(Gene gene) GeneOntologyServiceImpl.getGOTerms(Gene gene, boolean includePartOf, GeneOntologyServiceImpl.GOAspect goAspect) GeneOntologyService.getValueObjects(Gene gene) Returns GO Terms VOs for the given Gene.GeneOntologyServiceImpl.getValueObjects(Gene gene) -
Uses of Gene in ubic.gemma.core.search
Methods in ubic.gemma.core.search that return types with arguments of type GeneModifier and TypeMethodDescriptiondefault Collection<SearchResult<Gene>> SearchSource.searchGene(SearchSettings settings, SearchContext context) Methods in ubic.gemma.core.search with parameters of type GeneModifier and TypeMethodDescriptionGeneSetSearch.findByGene(Gene gene) GeneSetSearchImpl.findByGene(Gene gene) Method parameters in ubic.gemma.core.search with type arguments of type GeneModifier and TypeMethodDescriptiondefault Collection<SearchResult<?>> SearchSource.searchBioSequenceAndGene(SearchSettings settings, SearchContext context, Collection<SearchResult<Gene>> previousGeneSearchResults) Deprecated. -
Uses of Gene in ubic.gemma.core.search.source
Methods in ubic.gemma.core.search.source that return types with arguments of type GeneModifier and TypeMethodDescriptionCompositeSearchSource.searchGene(SearchSettings settings, SearchContext context) DatabaseSearchSource.searchGene(SearchSettings settings, SearchContext context) Search the DB for genes that exactly match the given search string searches geneProducts, gene and bioSequence tablesGeneOntologySearchSource.searchGene(SearchSettings settings, SearchContext context) HibernateSearchSource.searchGene(SearchSettings settings, SearchContext context) Method parameters in ubic.gemma.core.search.source with type arguments of type GeneModifier and TypeMethodDescriptionCompositeSearchSource.searchBioSequenceAndGene(SearchSettings settings, SearchContext context, Collection<SearchResult<Gene>> previousGeneSearchResults) Deprecated.DatabaseSearchSource.searchBioSequenceAndGene(SearchSettings settings, SearchContext context, Collection<SearchResult<Gene>> previousGeneSearchResults) -
Uses of Gene in ubic.gemma.core.visualization
Methods in ubic.gemma.core.visualization that return types with arguments of type GeneModifier and TypeMethodDescriptionExpressionDataHeatmap.getGenes()List of genes to use for display purposes.Method parameters in ubic.gemma.core.visualization with type arguments of type GeneModifier and TypeMethodDescriptionstatic ExpressionDataHeatmapExpressionDataHeatmap.fromDesignElements(ExpressionExperiment ee, BioAssayDimension dimension, Slice<CompositeSequence> designElements, List<Gene> genes) Create a heatmap for a given set of design elements.static ExpressionDataHeatmapExpressionDataHeatmap.fromDesignElements(ExpressionExperimentSubSet subSet, BioAssayDimension dimension, Slice<CompositeSequence> designElements, List<Gene> genes) Create a heatmap for a subset using design elements.static ExpressionDataHeatmapExpressionDataHeatmap.fromVectors(ExpressionExperiment ee, BioAssayDimension dimension, Slice<? extends BulkExpressionDataVector> vectors, List<Gene> genes) Create a heatmap for a given set of vectors.static ExpressionDataHeatmapExpressionDataHeatmap.fromVectors(ExpressionExperimentSubSet subSet, BioAssayDimension dimension, Slice<? extends BulkExpressionDataVector> vectors, List<Gene> genes) Create a heatmap for a subset. -
Uses of Gene in ubic.gemma.core.visualization.cellbrowser
Method parameters in ubic.gemma.core.visualization.cellbrowser with type arguments of type GeneModifier and TypeMethodDescriptionintCellBrowserTabularMatrixWriter.write(Collection<SingleCellExpressionDataVector> vectors, Map<CompositeSequence, Set<Gene>> cs2gene, Writer writer) intCellBrowserTabularMatrixWriter.write(Stream<SingleCellExpressionDataVector> vectors, Map<CompositeSequence, Set<Gene>> cs2gene, Writer writer) -
Uses of Gene in ubic.gemma.model.analysis.expression.coexpression
Constructors in ubic.gemma.model.analysis.expression.coexpression with parameters of type GeneModifierConstructorDescriptionHumanCoexpressionSupportDetails(Gene firstGene, Gene secondGene, Boolean isPositive) MouseCoexpressionSupportDetails(Gene firstGene, Gene secondGene, Boolean isPositive) OtherCoexpressionSupportDetails(Gene firstGene, Gene secondGene, Boolean isPositive) RatCoexpressionSupportDetails(Gene firstGene, Gene secondGene, Boolean isPositive) SupportDetails(Gene firstGene, Gene secondGene, Boolean isPositive) Note that the gene information and isPositive is only used for bookkeeping during creation; it is not part of the persistent entity. -
Uses of Gene in ubic.gemma.model.analysis.expression.diff
Methods in ubic.gemma.model.analysis.expression.diff that return GeneMethods in ubic.gemma.model.analysis.expression.diff with parameters of type GeneModifier and TypeMethodDescriptionvoidConstructor parameters in ubic.gemma.model.analysis.expression.diff with type arguments of type GeneModifierConstructorDescriptionDifferentialExpressionAnalysisResultSetValueObject(ExpressionAnalysisResultSet analysisResultSet, boolean includeFactorValuesInContrasts, Map<Long, Set<Gene>> result2Genes, boolean includeTaxonInGenes) Create an expression analysis result set VO with all its associated results.DifferentialExpressionAnalysisResultValueObject(DifferentialExpressionAnalysisResult result, boolean includeFactorValuesInContrasts, Set<Gene> genes, boolean includeTaxonInGenes) -
Uses of Gene in ubic.gemma.model.association
Methods in ubic.gemma.model.association that return GeneModifier and TypeMethodDescriptionGene2GeneAssociation.getFirstGene()Gene2GOAssociation.getGene()Gene2GeneAssociation.getSecondGene()Methods in ubic.gemma.model.association with parameters of type GeneModifier and TypeMethodDescriptionstatic Gene2GOAssociationGene2GOAssociation.Factory.newInstance(Gene gene, Characteristic ontologyEntry, GOEvidenceCode evidenceCode) -
Uses of Gene in ubic.gemma.model.association.coexpression
Methods in ubic.gemma.model.association.coexpression with parameters of type GeneModifier and TypeMethodDescriptionstatic GeneCoexpressionNodeDegreeGeneCoexpressionNodeDegree.Factory.newInstance(Gene g) -
Uses of Gene in ubic.gemma.model.expression.bioAssayData
Constructor parameters in ubic.gemma.model.expression.bioAssayData with type arguments of type GeneModifierConstructorDescriptionExperimentExpressionLevelsValueObject(long datasetId, Map<Gene, List<DoubleVectorValueObject>> vectorsPerGene, boolean keepGeneNonSpecific, String conslidationMode) -
Uses of Gene in ubic.gemma.model.genome
Methods in ubic.gemma.model.genome that return Gene -
Uses of Gene in ubic.gemma.model.genome.gene
Methods in ubic.gemma.model.genome.gene that return GeneMethods in ubic.gemma.model.genome.gene with parameters of type GeneModifier and TypeMethodDescriptionstatic GeneSetMemberGeneSet.containsGene(Gene g, GeneSet gs) static GeneValueObjectGeneValueObject.convert2ValueObject(Gene gene) Converts a Gene to a GeneValueObjectstatic GeneSetMemberGeneSetMember.Factory.newInstance(Double score, Gene gene) voidvoidConstructors in ubic.gemma.model.genome.gene with parameters of type GeneModifierConstructorDescriptionGeneValueObject(Gene gene) GeneValueObject(Gene gene, boolean includeTaxon) -
Uses of Gene in ubic.gemma.persistence.persister
Methods in ubic.gemma.persistence.persister that return GeneModifier and TypeMethodDescriptionprotected GeneGenomePersister.persistGene(Gene gene, AbstractPersister.Caches caches) Methods in ubic.gemma.persistence.persister with parameters of type GeneModifier and TypeMethodDescriptionprotected GeneGenomePersister.persistGene(Gene gene, AbstractPersister.Caches caches) -
Uses of Gene in ubic.gemma.persistence.service.analysis.expression.diff
Methods in ubic.gemma.persistence.service.analysis.expression.diff that return types with arguments of type GeneModifier and TypeMethodDescriptionExpressionAnalysisResultSetService.loadResultIdToGenesMap(ExpressionAnalysisResultSet ears) ExpressionAnalysisResultSetServiceImpl.loadResultIdToGenesMap(ExpressionAnalysisResultSet resultSet) ExpressionAnalysisResultSetDao.loadResultToGenesMap(ExpressionAnalysisResultSet resultSet, boolean queryByResult) Load aDifferentialExpressionAnalysisResulttoGenemulti-map.ExpressionAnalysisResultSetDaoImpl.loadResultToGenesMap(ExpressionAnalysisResultSet resultSet, boolean queryByResult) Methods in ubic.gemma.persistence.service.analysis.expression.diff with parameters of type GeneModifier and TypeMethodDescriptionDifferentialExpressionResultDao.findByGene(Gene gene, boolean keepNonSpecificProbes) Find differential expression results for a given gene, grouped by experiment.DifferentialExpressionResultDao.findByGene(Gene gene, boolean keepNonSpecificProbes, double threshold, int limit) Find differential expression for a gene, exceeding a given significance level (using the corrected pvalue field)DifferentialExpressionResultDaoImpl.findByGene(Gene gene, boolean keepNonSpecificProbes) DifferentialExpressionResultDaoImpl.findByGene(Gene gene, boolean keepNonSpecificProbes, double threshold, int limit) DifferentialExpressionResultService.findByGene(Gene gene, boolean keepNonSpecificProbes) Returns a map of a collection ofDifferentialExpressionAnalysisResults keyed byExpressionExperiment.DifferentialExpressionResultService.findByGene(Gene gene, boolean keepNonSpecificProbes, double threshold, int limit) Find differential expression for a gene, exceeding a given significance level (using the corrected pvalue field)DifferentialExpressionResultServiceImpl.findByGene(Gene gene, boolean keepNonSpecificProbes) DifferentialExpressionResultServiceImpl.findByGene(Gene gene, boolean keepNonSpecificProbes, double threshold, int limit) DifferentialExpressionResultDao.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<Long> experimentAnalyzedIds, boolean includeSubSets) Find differential expression results for a given gene and set of experiments, grouped by experiment.DifferentialExpressionResultDao.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<Long> experimentsAnalyzed, boolean includeSubSets, double threshold, int limit) Find differential expression for a gene in given data sets, exceeding a given significance level (using the corrected pvalue field)DifferentialExpressionResultDao.findByGeneAndExperimentAnalyzed(Gene gene, Collection<Long> experimentAnalyzedIds, boolean includeSubsets, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, double threshold, boolean keepNonSpecificProbes, boolean initializeFactorValues) Retrieve differential expression results for a given gene across all the given datasets.DifferentialExpressionResultDaoImpl.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<Long> experimentAnalyzedIds, boolean includeSubSets) DifferentialExpressionResultDaoImpl.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<Long> experimentAnalyzedIds, boolean includeSubsets, double threshold, int limit) DifferentialExpressionResultDaoImpl.findByGeneAndExperimentAnalyzed(Gene gene, Collection<Long> experimentAnalyzedIds, boolean includeSubsets, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, double threshold, boolean keepNonSpecificProbes, boolean initializeFactorValues) DifferentialExpressionResultService.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<? extends BioAssaySet> experimentsAnalyzed, boolean includeSubSets) Returns a map of a collection ofDifferentialExpressionAnalysisResults keyed byExpressionExperiment.DifferentialExpressionResultService.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<? extends BioAssaySet> experimentsAnalyzed, boolean includeSubSets, double threshold, int limit) Find differential expression for a gene in given data sets, exceeding a given significance level (using the corrected pvalue field)DifferentialExpressionResultServiceImpl.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<? extends BioAssaySet> experimentsAnalyzed, boolean includeSubSets) DifferentialExpressionResultServiceImpl.findByGeneAndExperimentAnalyzed(Gene gene, boolean keepNonSpecificProbes, Collection<? extends BioAssaySet> experimentsAnalyzed, boolean includeSubSets, double threshold, int limit) DifferentialExpressionResultService.findByGeneAndExperimentAnalyzedIds(Gene gene, boolean keepNonSpecific, Collection<Long> experimentAnalyzedIds, boolean includeSubSets, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, double threshold, boolean initializeFactorValues) DifferentialExpressionResultServiceImpl.findByGeneAndExperimentAnalyzedIds(Gene gene, boolean keepNonSpecific, Collection<Long> experimentAnalyzedIds, boolean includeSubSets, Map<DifferentialExpressionAnalysisResult, Long> sourceExperimentIdMap, Map<DifferentialExpressionAnalysisResult, Long> experimentAnalyzedIdMap, Map<DifferentialExpressionAnalysisResult, Baseline> baselineMap, double threshold, boolean initializeFactorValues) DifferentialExpressionAnalysisDao.findExperimentsWithAnalyses(Gene gene) DifferentialExpressionAnalysisService.findExperimentsWithAnalyses(Gene gene) DifferentialExpressionAnalysisServiceImpl.findExperimentsWithAnalyses(Gene gene) -
Uses of Gene in ubic.gemma.persistence.service.association
Methods in ubic.gemma.persistence.service.association that return types with arguments of type GeneModifier and TypeMethodDescriptionGene2GOAssociationDao.findByGenes(Collection<Gene> genes) Gene2GOAssociationDaoImpl.findByGenes(Collection<Gene> genes) Gene2GOAssociationService.findByGenes(Collection<Gene> genes) Gene2GOAssociationServiceImpl.findByGenes(Collection<Gene> genes) Gene2GOAssociationDao.findByGoTermUris(Collection<String> uris) Gene2GOAssociationDao.findByGoTermUris(Collection<String> uris, Taxon taxon) Gene2GOAssociationDaoImpl.findByGoTermUris(Collection<String> uris) Gene2GOAssociationDaoImpl.findByGoTermUris(Collection<String> uris, Taxon taxon) Gene2GOAssociationService.findByGOTermUris(Collection<String> uris, Taxon taxon) Find all the genes that match any of the terms.Gene2GOAssociationServiceImpl.findByGOTermUris(Collection<String> uris, Taxon taxon) Gene2GOAssociationDao.findByGoTermUrisPerTaxon(Collection<String> uris) Gene2GOAssociationDaoImpl.findByGoTermUrisPerTaxon(Collection<String> uris) Gene2GOAssociationService.findByGOTermUrisPerTaxon(Collection<String> uris) Find all genes associated with a given set of GO terms, grouped by taxon.Gene2GOAssociationServiceImpl.findByGOTermUrisPerTaxon(Collection<String> uris) Methods in ubic.gemma.persistence.service.association with parameters of type GeneModifier and TypeMethodDescriptionGene2GOAssociationDao.findAssociationByGene(Gene gene) Gene2GOAssociationDaoImpl.findAssociationByGene(Gene gene) Gene2GOAssociationService.findAssociationByGene(Gene gene) Gene2GOAssociationServiceImpl.findAssociationByGene(Gene gene) Gene2GOAssociationDao.findByGene(Gene gene) Gene2GOAssociationDaoImpl.findByGene(Gene gene) Gene2GOAssociationService.findByGene(Gene gene) Gene2GOAssociationServiceImpl.findByGene(Gene gene) Method parameters in ubic.gemma.persistence.service.association with type arguments of type GeneModifier and TypeMethodDescriptionGene2GOAssociationDao.findAssociationByGenes(Collection<Gene> genes) Gene2GOAssociationDaoImpl.findAssociationByGenes(Collection<Gene> genes) Gene2GOAssociationService.findAssociationByGenes(Collection<Gene> genes) Gene2GOAssociationServiceImpl.findAssociationByGenes(Collection<Gene> genes) Gene2GOAssociationDao.findByGenes(Collection<Gene> genes) Gene2GOAssociationDaoImpl.findByGenes(Collection<Gene> genes) Gene2GOAssociationService.findByGenes(Collection<Gene> genes) Gene2GOAssociationServiceImpl.findByGenes(Collection<Gene> genes) -
Uses of Gene in ubic.gemma.persistence.service.association.coexpression
Methods in ubic.gemma.persistence.service.association.coexpression that return types with arguments of type GeneModifier and TypeMethodDescriptionCoexpressionDao.countOldLinks(Collection<Gene> genes) CoexpressionDaoImpl.countOldLinks(Collection<Gene> genes) CoexpressionService.countOldLinks(Collection<Gene> genes) CoexpressionServiceImpl.countOldLinks(Collection<Gene> genes) Methods in ubic.gemma.persistence.service.association.coexpression with parameters of type GeneModifier and TypeMethodDescriptionCoexpressionDao.countLinks(Gene gene, ExpressionExperiment ee) CoexpressionDaoImpl.countLinks(Gene gene, ExpressionExperiment ee) CoexpressionService.countLinks(ExpressionExperiment ee, Gene gene) CoexpressionServiceImpl.countLinks(ExpressionExperiment ee, Gene gene) LinkCreator.createSupportDetails(Gene g1, Gene g2, Boolean isPositive) CoexpressionDao.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int maxResults, boolean quick) Find coexpression links for a gene that are common to all the given datasets.CoexpressionDaoImpl.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int maxResults, boolean quick) CoexpressionService.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int maxResults, boolean quick) Find links which are common to all of the given data sets.CoexpressionService.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int stringency, int maxResults, boolean quick) Search for coexpression across all available data sets, for the given genes considered individually, subject to a stringency constraint.CoexpressionServiceImpl.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int maxResults, boolean quick) CoexpressionServiceImpl.findCoexpressionRelationships(Gene gene, Collection<Long> bas, int stringency, int maxResults, boolean quick) CoexpressionNodeDegreeDao.findOrCreate(Gene gene) CoexpressionNodeDegreeDaoImpl.findOrCreate(Gene gene) CoexpressionService.getNodeDegree(Gene g) CoexpressionServiceImpl.getNodeDegree(Gene g) CoexpressionDao.initializeFromOldData(Gene gene, Map<Long, Gene> geneIdMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionDaoImpl.initializeFromOldData(Gene gene, Map<Long, Gene> geneIdMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionService.initializeLinksFromOldData(Gene gene, Map<Long, Gene> idMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionServiceImpl.initializeLinksFromOldData(Gene g, Map<Long, Gene> idMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) intCoexpressionDao.queryAndCache(Gene gene) intCoexpressionDaoImpl.queryAndCache(Gene gene) CoexpressionDao.updateNodeDegree(Gene gene, GeneCoexpressionNodeDegree nd) This is a maintenance method.CoexpressionDaoImpl.updateNodeDegree(Gene g, GeneCoexpressionNodeDegree nd) Method parameters in ubic.gemma.persistence.service.association.coexpression with type arguments of type GeneModifier and TypeMethodDescriptionCoexpressionDao.countOldLinks(Collection<Gene> genes) CoexpressionDaoImpl.countOldLinks(Collection<Gene> genes) CoexpressionService.countOldLinks(Collection<Gene> genes) CoexpressionServiceImpl.countOldLinks(Collection<Gene> genes) voidCoexpressionDao.createOrUpdate(ExpressionExperiment bioAssaySet, List<NonPersistentNonOrderedCoexpLink> p2plinks, LinkCreator c, Set<Gene> genesTested) voidCoexpressionDaoImpl.createOrUpdate(ExpressionExperiment ee, List<NonPersistentNonOrderedCoexpLink> links, LinkCreator c, Set<Gene> genesTested) voidCoexpressionService.createOrUpdate(ExpressionExperiment ee, List<NonPersistentNonOrderedCoexpLink> links, LinkCreator c, Set<Gene> geesTested) Maintenance method.voidCoexpressionServiceImpl.createOrUpdate(ExpressionExperiment ee, List<NonPersistentNonOrderedCoexpLink> links, LinkCreator c, Set<Gene> genesTested) CoexpressionDao.initializeFromOldData(Gene gene, Map<Long, Gene> geneIdMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionDaoImpl.initializeFromOldData(Gene gene, Map<Long, Gene> geneIdMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionService.initializeLinksFromOldData(Gene gene, Map<Long, Gene> idMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) CoexpressionServiceImpl.initializeLinksFromOldData(Gene g, Map<Long, Gene> idMap, Map<NonPersistentNonOrderedCoexpLink, SupportDetails> linksSoFar, Set<Long> skipGenes) Constructors in ubic.gemma.persistence.service.association.coexpression with parameters of type Gene -
Uses of Gene in ubic.gemma.persistence.service.expression.arrayDesign
Methods in ubic.gemma.persistence.service.expression.arrayDesign that return types with arguments of type GeneModifier and TypeMethodDescriptionArrayDesignDao.getGenes(ArrayDesign arrayDesign) Obtain all the genes associated to the platform.ArrayDesignDaoImpl.getGenes(ArrayDesign arrayDesign) ArrayDesignService.getGenes(ArrayDesign arrayDesign) ArrayDesignServiceImpl.getGenes(ArrayDesign arrayDesign) ArrayDesignDao.getGenesByCompositeSequence(Collection<ArrayDesign> arrayDesign) ArrayDesignDao.getGenesByCompositeSequence(ArrayDesign arrayDesign) Obtain all the genes associated to the platform organized by corresponding design elements.ArrayDesignDaoImpl.getGenesByCompositeSequence(Collection<ArrayDesign> arrayDesign) ArrayDesignDaoImpl.getGenesByCompositeSequence(ArrayDesign arrayDesign) ArrayDesignService.getGenesByCompositeSequence(Collection<ArrayDesign> arrayDesign) ArrayDesignService.getGenesByCompositeSequence(ArrayDesign arrayDesign) ArrayDesignServiceImpl.getGenesByCompositeSequence(Collection<ArrayDesign> arrayDesign) ArrayDesignServiceImpl.getGenesByCompositeSequence(ArrayDesign arrayDesign) -
Uses of Gene in ubic.gemma.persistence.service.expression.bioAssayData
Methods in ubic.gemma.persistence.service.expression.bioAssayData that return types with arguments of type GeneModifier and TypeMethodDescriptionProcessedExpressionDataVectorDao.getRanks(Collection<ExpressionExperiment> expressionExperiments, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorDao.getRanks(ExpressionExperiment expressionExperiment, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorDaoImpl.getRanks(Collection<ExpressionExperiment> expressionExperiments, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorDaoImpl.getRanks(ExpressionExperiment expressionExperiment, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorService.getRanks(Collection<ExpressionExperiment> expressionExperiments, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorServiceImpl.getRanks(Collection<ExpressionExperiment> expressionExperiments, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) Method parameters in ubic.gemma.persistence.service.expression.bioAssayData with type arguments of type GeneModifier and TypeMethodDescriptionProcessedExpressionDataVectorDao.getRanks(ExpressionExperiment expressionExperiment, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) ProcessedExpressionDataVectorDaoImpl.getRanks(ExpressionExperiment expressionExperiment, Collection<Gene> genes, ProcessedExpressionDataVectorDao.RankMethod method) -
Uses of Gene in ubic.gemma.persistence.service.expression.designElement
Methods in ubic.gemma.persistence.service.expression.designElement that return types with arguments of type GeneModifier and TypeMethodDescriptionCompositeSequenceDao.getGenes(Collection<CompositeSequence> compositeSequences) Given a collection of composite sequences returns a map of the given composite sequences to a collection of genesCompositeSequenceDao.getGenes(CompositeSequence compositeSequence, int offset, int limit) given a composite sequence returns a collection of genesCompositeSequenceDaoImpl.getGenes(Collection<CompositeSequence> compositeSequences) CompositeSequenceDaoImpl.getGenes(CompositeSequence compositeSequence, int offset, int limit) CompositeSequenceService.getGenes(Collection<CompositeSequence> sequences) Given a Collection of composite sequences returns of map of a composite sequence to a collection of genesCompositeSequenceService.getGenes(CompositeSequence compositeSequence) CompositeSequenceService.getGenes(CompositeSequence compositeSequence, int offset, int limit) CompositeSequenceServiceImpl.getGenes(Collection<CompositeSequence> sequences) CompositeSequenceServiceImpl.getGenes(CompositeSequence compositeSequence) CompositeSequenceServiceImpl.getGenes(CompositeSequence compositeSequence, int offset, int limit) Methods in ubic.gemma.persistence.service.expression.designElement with parameters of type GeneModifier and TypeMethodDescriptionCompositeSequenceDao.findByGene(Gene gene) CompositeSequenceDao.findByGene(Gene gene, int start, int limit) CompositeSequenceDao.findByGene(Gene gene, ArrayDesign arrayDesign) CompositeSequenceDaoImpl.findByGene(Gene gene) CompositeSequenceDaoImpl.findByGene(Gene gene, int start, int limit) CompositeSequenceDaoImpl.findByGene(Gene gene, ArrayDesign arrayDesign) CompositeSequenceService.findByGene(Gene gene) CompositeSequenceService.findByGene(Gene gene, ArrayDesign arrayDesign) CompositeSequenceServiceImpl.findByGene(Gene gene) CompositeSequenceServiceImpl.findByGene(Gene gene, ArrayDesign arrayDesign) CompositeSequenceService.loadValueObjectsForGene(Gene gene, int start, int limit) CompositeSequenceServiceImpl.loadValueObjectsForGene(Gene gene, int start, int limit) -
Uses of Gene in ubic.gemma.persistence.service.expression.experiment
Methods in ubic.gemma.persistence.service.expression.experiment that return types with arguments of type GeneModifier and TypeMethodDescriptionExpressionExperimentDao.getGenesUsedByPreferredVectors(ExpressionExperiment experimentConstraint) Obtain genes used by the processed vectors of this dataset.ExpressionExperimentDaoImpl.getGenesUsedByPreferredVectors(ExpressionExperiment experimentConstraint) ExpressionExperimentService.getGenesUsedByPreferredVectors(ExpressionExperiment experimentConstraint) Retrieve the genes used by the preferred vectors of this experiment.ExpressionExperimentServiceImpl.getGenesUsedByPreferredVectors(ExpressionExperiment experimentConstraint) Methods in ubic.gemma.persistence.service.expression.experiment with parameters of type GeneModifier and TypeMethodDescriptionExpressionExperimentDao.findByExpressedGene(Gene gene, Double rank) ExpressionExperimentDaoImpl.findByExpressedGene(Gene gene, Double rank) ExpressionExperimentService.findByExpressedGene(Gene gene, double rank) ExpressionExperimentServiceImpl.findByExpressedGene(Gene gene, double rank) ExpressionExperimentDao.findByGene(Gene gene) ExpressionExperimentDaoImpl.findByGene(Gene gene) uses GENE2CS table.ExpressionExperimentService.findByGene(Gene gene) ExpressionExperimentServiceImpl.findByGene(Gene gene) -
Uses of Gene in ubic.gemma.persistence.service.genome
Methods in ubic.gemma.persistence.service.genome that return GeneModifier and TypeMethodDescriptionGeneDao.findByAccession(String accession, ExternalDatabase source) GeneDaoImpl.findByAccession(String accession, ExternalDatabase source) GeneDao.findByEnsemblId(String exactString) GeneDaoImpl.findByEnsemblId(String id) GeneDao.findByNcbiId(Integer accession) GeneDaoImpl.findByNcbiId(Integer ncbiId) GeneDao.findByOfficialSymbol(String symbol, Taxon taxon) GeneDaoImpl.findByOfficialSymbol(String symbol, Taxon taxon) GeneDao.thawAliases(Gene gene) GeneDaoImpl.thawAliases(Gene gene) Only thaw the Aliases, very light versionMethods in ubic.gemma.persistence.service.genome that return types with arguments of type GeneModifier and TypeMethodDescriptionGeneDao.find(PhysicalLocation physicalLocation) Find all genes at a physical location.GeneDaoImpl.find(PhysicalLocation physicalLocation) GeneDao.findByAlias(String search) Locate genes that match the given alias stringGeneDaoImpl.findByAlias(String search) Gets all the genes referred to by the alias defined by the search string.GeneDao.findByNcbiIds(Collection<Integer> ncbiIds) Quickly load exact matches.GeneDaoImpl.findByNcbiIds(Collection<Integer> ncbiIds) GeneDao.findByOfficialName(String officialName) GeneDaoImpl.findByOfficialName(String officialName) GeneDao.findByOfficialNameInexact(String officialName) GeneDaoImpl.findByOfficialNameInexact(String officialName) GeneDao.findByOfficialSymbol(String officialSymbol) GeneDaoImpl.findByOfficialSymbol(String officialSymbol) GeneDao.findByOfficialSymbolInexact(String officialSymbol) GeneDaoImpl.findByOfficialSymbolInexact(String officialSymbol) GeneDao.findByOfficialSymbols(Collection<String> query, Long taxonId) Quickly load exact matches.GeneDaoImpl.findByOfficialSymbols(Collection<String> query, Long taxonId) GeneDao.findByPhysicalLocation(PhysicalLocation location) Deprecated.GeneDaoImpl.findByPhysicalLocation(PhysicalLocation location) GeneDao.getMicroRnaByTaxon(Taxon taxon) GeneDaoImpl.getMicroRnaByTaxon(Taxon taxon) GeneDao.loadKnownGenes(Taxon taxon) GeneDaoImpl.loadKnownGenes(Taxon taxon) GeneDao.loadThawed(Collection<Long> ids) GeneDaoImpl.loadThawed(Collection<Long> ids) GeneDao.loadThawedLiter(Collection<Long> ids) GeneDaoImpl.loadThawedLiter(Collection<Long> ids) GeneDao.thawLite(Collection<Gene> genes) GeneDaoImpl.thawLite(Collection<Gene> genes) Methods in ubic.gemma.persistence.service.genome with parameters of type GeneModifier and TypeMethodDescriptionprotected GeneValueObjectGeneDaoImpl.doLoadValueObject(Gene entity) longGeneDao.getCompositeSequenceCount(Gene gene, boolean includeDummyProducts) Obtain the number of platform elements (e.g.longGeneDaoImpl.getCompositeSequenceCount(Gene gene, boolean includeDummyProducts) GeneDao.getCompositeSequences(Gene gene, boolean includeDummyProducts) Get the composite sequences (e.g.GeneDao.getCompositeSequences(Gene gene, ArrayDesign arrayDesign, boolean includeDummyProducts) Get the composite sequences (e.g.GeneDaoImpl.getCompositeSequences(Gene gene, boolean includeDummyProducts) GeneDaoImpl.getCompositeSequences(Gene gene, ArrayDesign arrayDesign, boolean includeDummyProducts) protected voidGeneDaoImpl.initializeCachedFilteringResult(Gene entity) voidGeneDao.thawAliases(Gene gene) GeneDaoImpl.thawAliases(Gene gene) Only thaw the Aliases, very light versionMethod parameters in ubic.gemma.persistence.service.genome with type arguments of type GeneModifier and TypeMethodDescriptionGeneDao.thawLite(Collection<Gene> genes) GeneDaoImpl.thawLite(Collection<Gene> genes) -
Uses of Gene in ubic.gemma.persistence.service.genome.biosequence
Methods in ubic.gemma.persistence.service.genome.biosequence that return types with arguments of type GeneModifier and TypeMethodDescriptionBioSequenceDao.findByGenes(Collection<Gene> genes) Returns matching biosequences for the given genes in a Map (gene to biosequences).BioSequenceDaoImpl.findByGenes(Collection<Gene> genes) BioSequenceService.findByGenes(Collection<Gene> genes) BioSequenceServiceImpl.findByGenes(Collection<Gene> genes) BioSequenceDao.getGenesByAccession(String search) BioSequenceDaoImpl.getGenesByAccession(String search) BioSequenceService.getGenesByAccession(String search) BioSequenceServiceImpl.getGenesByAccession(String search) BioSequenceDao.getGenesByName(String search) For a biosequence name, get the genesBioSequenceDaoImpl.getGenesByName(String search) BioSequenceService.getGenesByName(String search) BioSequenceServiceImpl.getGenesByName(String search) Method parameters in ubic.gemma.persistence.service.genome.biosequence with type arguments of type GeneModifier and TypeMethodDescriptionBioSequenceDao.findByGenes(Collection<Gene> genes) Returns matching biosequences for the given genes in a Map (gene to biosequences).BioSequenceDaoImpl.findByGenes(Collection<Gene> genes) BioSequenceService.findByGenes(Collection<Gene> genes) BioSequenceServiceImpl.findByGenes(Collection<Gene> genes) -
Uses of Gene in ubic.gemma.persistence.service.genome.gene
Methods in ubic.gemma.persistence.service.genome.gene that return GeneModifier and TypeMethodDescriptionGeneService.findByAccession(String accession, ExternalDatabase source) GeneServiceImpl.findByAccession(String accession, ExternalDatabase source) GeneService.findByEnsemblId(String exactString) Searches for a gene based on its ensembl ID.GeneServiceImpl.findByEnsemblId(String exactString) GeneService.findByNCBIId(Integer accession) GeneServiceImpl.findByNCBIId(Integer accession) GeneService.findByOfficialSymbol(String symbol, Taxon taxon) GeneServiceImpl.findByOfficialSymbol(String symbol, Taxon taxon) GeneService.thawAliases(Gene gene) GeneServiceImpl.thawAliases(Gene gene) Methods in ubic.gemma.persistence.service.genome.gene that return types with arguments of type GeneModifier and TypeMethodDescriptionGeneService.find(PhysicalLocation physicalLocation) Find all genes at a physical location.GeneServiceImpl.find(PhysicalLocation physicalLocation) GeneService.findByAlias(String search) GeneServiceImpl.findByAlias(String search) GeneService.findByOfficialName(String officialName) GeneServiceImpl.findByOfficialName(String officialName) GeneService.findByOfficialNameInexact(String officialName) GeneServiceImpl.findByOfficialNameInexact(String officialName) GeneService.findByOfficialSymbol(String officialSymbol) GeneServiceImpl.findByOfficialSymbol(String officialSymbol) GeneService.findByOfficialSymbolInexact(String officialSymbol) GeneServiceImpl.findByOfficialSymbolInexact(String officialSymbol) GeneProductDao.getGenesByName(String search) GeneProductDaoImpl.getGenesByName(String search) GeneProductService.getGenesByName(String search) GeneProductServiceImpl.getGenesByName(String search) GeneProductDao.getGenesByNcbiId(String search) GeneProductDaoImpl.getGenesByNcbiId(String search) GeneProductService.getGenesByNcbiId(String search) GeneProductServiceImpl.getGenesByNcbiId(String search) GeneSearchService.getGOGroupGenes(String goQuery, Taxon taxon) GeneSearchServiceImpl.getGOGroupGenes(String goQuery, Taxon taxon) GeneService.loadMicroRNAs(Taxon taxon) GeneServiceImpl.loadMicroRNAs(Taxon taxon) GeneService.loadThawed(Collection<Long> ids) Load with objects already thawed.GeneServiceImpl.loadThawed(Collection<Long> ids) GeneService.loadThawedLiter(Collection<Long> ids) GeneServiceImpl.loadThawedLiter(Collection<Long> ids) GeneService.thawLite(Collection<Gene> genes) GeneServiceImpl.thawLite(Collection<Gene> genes) Methods in ubic.gemma.persistence.service.genome.gene with parameters of type GeneModifier and TypeMethodDescriptionGeneSetDao.findByGene(Gene gene) GeneSetDaoImpl.findByGene(Gene gene) GeneSetService.findByGene(Gene gene) Return all sets that contain the given gene.GeneSetServiceImpl.findByGene(Gene gene) longGeneService.getCompositeSequenceCount(Gene gene, boolean includeDummyProducts) longGeneServiceImpl.getCompositeSequenceCount(Gene gene, boolean includeDummyProducts) GeneService.getCompositeSequences(Gene gene, boolean includeDummyProducts) GeneService.getCompositeSequences(Gene gene, ArrayDesign arrayDesign, boolean includeDummyProducts) GeneServiceImpl.getCompositeSequences(Gene gene, boolean includeDummyProducts) GeneServiceImpl.getCompositeSequences(Gene gene, ArrayDesign arrayDesign, boolean includeDummyProducts) GeneService.getPhysicalLocationsValueObjects(Gene gene) GeneServiceImpl.getPhysicalLocationsValueObjects(Gene gene) voidGeneService.thawAliases(Gene gene) GeneServiceImpl.thawAliases(Gene gene) Method parameters in ubic.gemma.persistence.service.genome.gene with type arguments of type GeneModifier and TypeMethodDescriptionGeneService.thawLite(Collection<Gene> genes) GeneServiceImpl.thawLite(Collection<Gene> genes) -
Uses of Gene in ubic.gemma.persistence.service.genome.sequenceAnalysis
Methods in ubic.gemma.persistence.service.genome.sequenceAnalysis with parameters of type GeneModifier and TypeMethodDescription -
Uses of Gene in ubic.gemma.persistence.util
Methods in ubic.gemma.persistence.util that return types with arguments of type GeneModifier and TypeMethodDescriptionstatic Map<CompositeSequence, Collection<Gene>> CommonQueries.getCs2GeneMap(Collection<Gene> genes, Collection<ArrayDesign> arrayDesigns, Session session) static Map<CompositeSequence, Collection<Gene>> CommonQueries.getCs2GeneMap(Collection<Gene> genes, Session session) Methods in ubic.gemma.persistence.util with parameters of type GeneModifier and TypeMethodDescriptionstatic voidBusinessKey.addRestrictions(Criteria queryObject, Gene gene, boolean stricter) static voidBusinessKey.attachCriteria(Criteria queryObject, Gene gene, String propertyName) Restricts the query to the provided Gene.static voidstatic voidBusinessKey.checkValidKey(Gene gene) static voidBusinessKey.createQueryObject(Criteria queryObject, Gene gene) static Collection<CompositeSequence> CommonQueries.getCompositeSequences(Gene gene, Session session) Given a gene, get all the composite sequences that map to it.Method parameters in ubic.gemma.persistence.util with type arguments of type GeneModifier and TypeMethodDescriptionstatic Map<CompositeSequence, Collection<Gene>> CommonQueries.getCs2GeneMap(Collection<Gene> genes, Collection<ArrayDesign> arrayDesigns, Session session) static Map<CompositeSequence, Collection<Gene>> CommonQueries.getCs2GeneMap(Collection<Gene> genes, Session session) -
Uses of Gene in ubic.gemma.rest.util.args
Methods in ubic.gemma.rest.util.args that return GeneModifier and TypeMethodDescriptionGeneArgService.getEntity(AbstractEntityArg<?, Gene, GeneService> entityArg) Retrieve the entity represented by this argument.GeneArgService.getEntityWithTaxon(GeneArg<?> entityArg, Taxon taxon) Obtain a gene from a specific taxon.Methods in ubic.gemma.rest.util.args that return types with arguments of type GeneModifier and TypeMethodDescriptionGeneArgService.getEntitiesWithTaxon(GeneArg<?> genes, Taxon taxon) Obtain genes from a specific taxon.GeneArgService.getEntitiesWithTaxon(GeneArrayArg genes, Taxon taxon) Obtain genes from a specific taxon.Method parameters in ubic.gemma.rest.util.args with type arguments of type GeneModifier and TypeMethodDescriptionGeneArgService.getEntity(AbstractEntityArg<?, Gene, GeneService> entityArg) Retrieve the entity represented by this argument. -
Uses of Gene in ubic.gemma.web.controller.expression.experiment
Methods in ubic.gemma.web.controller.expression.experiment that return GeneConstructors in ubic.gemma.web.controller.expression.experiment with parameters of type GeneModifierConstructorDescriptionSingleCellExpressionDataModel(ExpressionExperiment expressionExperiment, Collection<CellTypeAssignment> cellTypeAssignments, Collection<CellLevelCharacteristics> cellLevelCharacteristics, QuantitationType quantitationType, CompositeSequence designElement, Gene gene, Long[] assayIds, CellTypeAssignment cellTypeAssignment, CellLevelCharacteristics cellLevelCharacteristics1, Characteristic focusedCharacteristic, String keywords, String font)
SearchSource.searchBioSequence(SearchSettings, SearchContext)(SearchSettings)} instead