diff --git a/scientific-skills/anndata/SKILL.md b/scientific-skills/anndata/SKILL.md index 0afa26c..28e0986 100644 --- a/scientific-skills/anndata/SKILL.md +++ b/scientific-skills/anndata/SKILL.md @@ -1,6 +1,6 @@ --- name: anndata -description: This skill should be used when working with annotated data matrices in Python, particularly for single-cell genomics analysis, managing experimental measurements with metadata, or handling large-scale biological datasets. Use when tasks involve AnnData objects, h5ad files, single-cell RNA-seq data, or integration with scanpy/scverse tools. +description: Data structure for annotated matrices in single-cell analysis. Use when working with .h5ad files or integrating with the scverse ecosystem. This is the data format skill—for analysis workflows use scanpy; for probabilistic models use scvi-tools; for population-scale queries use cellxgene-census. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/biopython/SKILL.md b/scientific-skills/biopython/SKILL.md index a24e816..04325c4 100644 --- a/scientific-skills/biopython/SKILL.md +++ b/scientific-skills/biopython/SKILL.md @@ -1,6 +1,6 @@ --- name: biopython -description: "Primary Python toolkit for molecular biology. Preferred for Python-based PubMed/NCBI queries (Bio.Entrez), sequence manipulation, file parsing (FASTA, GenBank, FASTQ, PDB), advanced BLAST workflows, structures, phylogenetics. For quick BLAST, use gget. For direct REST API, use pubmed-database." +description: Comprehensive molecular biology toolkit. Use for sequence manipulation, file parsing (FASTA/GenBank/PDB), phylogenetics, and programmatic NCBI/PubMed access (Bio.Entrez). Best for batch processing, custom bioinformatics pipelines, BLAST automation. For quick lookups use gget; for multi-service integration use bioservices. license: Unknown metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/bioservices/SKILL.md b/scientific-skills/bioservices/SKILL.md index 4a81d60..dcf2f4a 100644 --- a/scientific-skills/bioservices/SKILL.md +++ b/scientific-skills/bioservices/SKILL.md @@ -1,6 +1,6 @@ --- name: bioservices -description: "Primary Python tool for 40+ bioinformatics services. Preferred for multi-database workflows: UniProt, KEGG, ChEMBL, PubChem, Reactome, QuickGO. Unified API for queries, ID mapping, pathway analysis. For direct REST control, use individual database skills (uniprot-database, kegg-database)." +description: Unified Python interface to 40+ bioinformatics services. Use when querying multiple databases (UniProt, KEGG, ChEMBL, Reactome) in a single workflow with consistent API. Best for cross-database analysis, ID mapping across services. For quick single-database lookups use gget; for sequence/file manipulation use biopython. license: GPLv3 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/cellxgene-census/SKILL.md b/scientific-skills/cellxgene-census/SKILL.md index 37bc6a3..a16d0c0 100644 --- a/scientific-skills/cellxgene-census/SKILL.md +++ b/scientific-skills/cellxgene-census/SKILL.md @@ -1,6 +1,6 @@ --- name: cellxgene-census -description: "Query CZ CELLxGENE Census (61M+ cells). Filter by cell type/tissue/disease, retrieve expression data, integrate with scanpy/PyTorch, for population-scale single-cell analysis." +description: Query the CELLxGENE Census (61M+ cells) programmatically. Use when you need expression data across tissues, diseases, or cell types from the largest curated single-cell atlas. Best for population-scale queries, reference atlas comparisons. For analyzing your own data use scanpy or scvi-tools. license: Unknown metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/cirq/SKILL.md b/scientific-skills/cirq/SKILL.md index 3ef9804..702a45f 100644 --- a/scientific-skills/cirq/SKILL.md +++ b/scientific-skills/cirq/SKILL.md @@ -1,6 +1,6 @@ --- name: cirq -description: Quantum computing framework for building, simulating, optimizing, and executing quantum circuits. Use this skill when working with quantum algorithms, quantum circuit design, quantum simulation (noiseless or noisy), running on quantum hardware (Google, IonQ, AQT, Pasqal), circuit optimization and compilation, noise modeling and characterization, or quantum experiments and benchmarking (VQE, QAOA, QPE, randomized benchmarking). +description: Google's quantum computing framework. Use when targeting Google Quantum AI hardware, designing noise-aware circuits, or running quantum characterization experiments. Best for Google hardware, noise modeling, and low-level circuit design. For IBM hardware use qiskit; for quantum ML with autodiff use pennylane; for physics simulations use qutip. license: Apache-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/dask/SKILL.md b/scientific-skills/dask/SKILL.md index bb83650..ca4b62c 100644 --- a/scientific-skills/dask/SKILL.md +++ b/scientific-skills/dask/SKILL.md @@ -1,6 +1,6 @@ --- name: dask -description: "Parallel/distributed computing. Scale pandas/NumPy beyond memory, parallel DataFrames/Arrays, multi-file processing, task graphs, for larger-than-RAM datasets and parallel workflows." +description: Distributed computing for larger-than-RAM pandas/NumPy workflows. Use when you need to scale existing pandas/NumPy code beyond memory or across clusters. Best for parallel file processing, distributed ML, integration with existing pandas code. For out-of-core analytics on single machine use vaex; for in-memory speed use polars. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/deepchem/SKILL.md b/scientific-skills/deepchem/SKILL.md index 2024794..ef85fdb 100644 --- a/scientific-skills/deepchem/SKILL.md +++ b/scientific-skills/deepchem/SKILL.md @@ -1,6 +1,6 @@ --- name: deepchem -description: "Molecular machine learning toolkit. Property prediction (ADMET, toxicity), GNNs (GCN, MPNN), MoleculeNet benchmarks, pretrained models, featurization, for drug discovery ML." +description: Molecular ML with diverse featurizers and pre-built datasets. Use for property prediction (ADMET, toxicity) with traditional ML or GNNs when you want extensive featurization options and MoleculeNet benchmarks. Best for quick experiments with pre-trained models, diverse molecular representations. For graph-first PyTorch workflows use torchdrug; for benchmark datasets use pytdc. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/gget/SKILL.md b/scientific-skills/gget/SKILL.md index 1cd2c6d..745a2ac 100644 --- a/scientific-skills/gget/SKILL.md +++ b/scientific-skills/gget/SKILL.md @@ -1,6 +1,6 @@ --- name: gget -description: "CLI/Python toolkit for rapid bioinformatics queries. Preferred for quick BLAST searches. Access to 20+ databases: gene info (Ensembl/UniProt), AlphaFold, ARCHS4, Enrichr, OpenTargets, COSMIC, genome downloads. For advanced BLAST/batch processing, use biopython. For multi-database integration, use bioservices." +descriptipn: Fast CLI/Python queries to 20+ bioinformatics databases. Use for quick lookups: gene info, BLAST searches, AlphaFold structures, enrichment analysis. Best for interactive exploration, simple queries. For batch processing or advanced BLAST use biopython; for multi-database Python workflows use bioservices. license: BSD-2-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/histolab/SKILL.md b/scientific-skills/histolab/SKILL.md index f04ae1f..0bd4d02 100644 --- a/scientific-skills/histolab/SKILL.md +++ b/scientific-skills/histolab/SKILL.md @@ -1,6 +1,6 @@ --- name: histolab -description: Digital pathology image processing toolkit for whole slide images (WSI). Use this skill when working with histopathology slides, processing H&E or IHC stained tissue images, extracting tiles from gigapixel pathology images, detecting tissue regions, segmenting tissue masks, or preparing datasets for computational pathology deep learning pipelines. Applies to WSI formats (SVS, TIFF, NDPI), tile-based analysis, and histological image preprocessing workflows. +description: Lightweight WSI tile extraction and preprocessing. Use for basic slide processing tissue detection, tile extraction, stain normalization for H&E images. Best for simple pipelines, dataset preparation, quick tile-based analysis. For advanced spatial proteomics, multiplexed imaging, or deep learning pipelines use pathml. license: Apache-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/hypogenic/SKILL.md b/scientific-skills/hypogenic/SKILL.md index f6a5e71..6f6106a 100644 --- a/scientific-skills/hypogenic/SKILL.md +++ b/scientific-skills/hypogenic/SKILL.md @@ -1,6 +1,6 @@ --- name: hypogenic -description: Automated hypothesis generation and testing using large language models. Use this skill when generating scientific hypotheses from datasets, combining literature insights with empirical data, testing hypotheses against observational data, or conducting systematic hypothesis exploration for research discovery in domains like deception detection, AI content detection, mental health analysis, or other empirical research tasks. +description: Automated LLM-driven hypothesis generation and testing on tabular datasets. Use when you want to systematically explore hypotheses about patterns in empirical data (e.g., deception detection, content analysis). Combines literature insights with data-driven hypothesis testing. For manual hypothesis formulation use hypothesis-generation; for creative ideation use scientific-brainstorming. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/hypothesis-generation/SKILL.md b/scientific-skills/hypothesis-generation/SKILL.md index 6a63df1..fb03078 100644 --- a/scientific-skills/hypothesis-generation/SKILL.md +++ b/scientific-skills/hypothesis-generation/SKILL.md @@ -1,6 +1,6 @@ --- name: hypothesis-generation -description: "Generate testable hypotheses. Formulate from observations, design experiments, explore competing explanations, develop predictions, propose mechanisms, for scientific inquiry across domains." +description: Structured hypothesis formulation from observations. Use when you have experimental observations or data and need to formulate testable hypotheses with predictions, propose mechanisms, and design experiments to test them. Follows scientific method framework. For open-ended ideation use scientific-brainstorming; for automated LLM-driven hypothesis testing on datasets use hypogenic. allowed-tools: [Read, Write, Edit, Bash] license: MIT license metadata: diff --git a/scientific-skills/matchms/SKILL.md b/scientific-skills/matchms/SKILL.md index 0f217bb..f9ea1f7 100644 --- a/scientific-skills/matchms/SKILL.md +++ b/scientific-skills/matchms/SKILL.md @@ -1,6 +1,6 @@ --- name: matchms -description: "Mass spectrometry analysis. Process mzML/MGF/MSP, spectral similarity (cosine, modified cosine), metadata harmonization, compound ID, for metabolomics and MS data processing." +description: Spectral similarity and compound identification for metabolomics. Use for comparing mass spectra, computing similarity scores (cosine, modified cosine), and identifying unknown compounds from spectral libraries. Best for metabolite identification, spectral matching, library searching. For full LC-MS/MS proteomics pipelines use pyopenms. license: Apache-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/matplotlib/SKILL.md b/scientific-skills/matplotlib/SKILL.md index 88aaa79..6652c15 100644 --- a/scientific-skills/matplotlib/SKILL.md +++ b/scientific-skills/matplotlib/SKILL.md @@ -1,6 +1,6 @@ --- name: matplotlib -description: "Foundational plotting library. Create line plots, scatter, bar, histograms, heatmaps, 3D, subplots, export PNG/PDF/SVG, for scientific visualization and publication figures." +description: Low-level plotting library for full customization. Use when you need fine-grained control over every plot element, creating novel plot types, or integrating with specific scientific workflows. Export to PNG/PDF/SVG for publication. For quick statistical plots use seaborn; for interactive plots use plotly; for publication-ready multi-panel figures with journal styling, use scientific-visualization. license: https://github.com/matplotlib/matplotlib/tree/main/LICENSE metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/opentrons-integration/SKILL.md b/scientific-skills/opentrons-integration/SKILL.md index c5605b6..e37d781 100644 --- a/scientific-skills/opentrons-integration/SKILL.md +++ b/scientific-skills/opentrons-integration/SKILL.md @@ -1,6 +1,6 @@ --- name: opentrons-integration -description: "Lab automation platform for Flex/OT-2 robots. Write Protocol API v2 protocols, liquid handling, hardware modules (heater-shaker, thermocycler), labware management, for automated pipetting workflows." +description: Official Opentrons Protocol API for OT-2 and Flex robots. Use when writing protocols specifically for Opentrons hardware with full access to Protocol API v2 features. Best for production Opentrons protocols, official API compatibility. For multi-vendor automation or broader equipment control use pylabrobot. license: Unknown metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/pathml/SKILL.md b/scientific-skills/pathml/SKILL.md index dd57ba4..172cbad 100644 --- a/scientific-skills/pathml/SKILL.md +++ b/scientific-skills/pathml/SKILL.md @@ -1,6 +1,6 @@ --- name: pathml -description: Computational pathology toolkit for analyzing whole-slide images (WSI) and multiparametric imaging data. Use this skill when working with histopathology slides, H&E stained images, multiplex immunofluorescence (CODEX, Vectra), spatial proteomics, nucleus detection/segmentation, tissue graph construction, or training ML models on pathology data. Supports 160+ slide formats including Aperio SVS, NDPI, DICOM, OME-TIFF for digital pathology workflows. +description: Full-featured computational pathology toolkit. Use for advanced WSI analysis including multiplexed immunofluorescence (CODEX, Vectra), nucleus segmentation, tissue graph construction, and ML model training on pathology data. Supports 160+ slide formats. For simple tile extraction from H&E slides, histolab may be simpler. license: GPL-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/peer-review/SKILL.md b/scientific-skills/peer-review/SKILL.md index 9f1a1d5..fbc0ca3 100644 --- a/scientific-skills/peer-review/SKILL.md +++ b/scientific-skills/peer-review/SKILL.md @@ -1,6 +1,6 @@ --- name: peer-review -description: "Systematic peer review toolkit. Evaluate methodology, statistics, design, reproducibility, ethics, figure integrity, reporting standards, for manuscript and grant review across disciplines." +description: Structured manuscript/grant review with checklist-based evaluation. Use when writing formal peer reviews with specific criteria methodology assessment, statistical validity, reporting standards compliance (CONSORT/STROBE), and constructive feedback. Best for actual review writing, manuscript revision. For evaluating claims/evidence quality use scientific-critical-thinking; for quantitative scoring frameworks use scholar-evaluation. allowed-tools: [Read, Write, Edit, Bash] license: MIT license metadata: diff --git a/scientific-skills/pennylane/SKILL.md b/scientific-skills/pennylane/SKILL.md index 5a41246..8cedc21 100644 --- a/scientific-skills/pennylane/SKILL.md +++ b/scientific-skills/pennylane/SKILL.md @@ -1,6 +1,6 @@ --- name: pennylane -description: Cross-platform Python library for quantum computing, quantum machine learning, and quantum chemistry. Enables building and training quantum circuits with automatic differentiation, seamless integration with PyTorch/JAX/TensorFlow, and device-independent execution across simulators and quantum hardware (IBM, Amazon Braket, Google, Rigetti, IonQ, etc.). Use when working with quantum circuits, variational quantum algorithms (VQE, QAOA), quantum neural networks, hybrid quantum-classical models, molecular simulations, quantum chemistry calculations, or any quantum computing tasks requiring gradient-based optimization, hardware-agnostic programming, or quantum machine learning workflows. +description: Hardware-agnostic quantum ML framework with automatic differentiation. Use when training quantum circuits via gradients, building hybrid quantum-classical models, or needing device portability across IBM/Google/Rigetti/IonQ. Best for variational algorithms (VQE, QAOA), quantum neural networks, and integration with PyTorch/JAX/TensorFlow. For hardware-specific optimizations use qiskit (IBM) or cirq (Google); for open quantum systems use qutip. license: Apache-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/plotly/SKILL.md b/scientific-skills/plotly/SKILL.md index 78c20cf..ad4524a 100644 --- a/scientific-skills/plotly/SKILL.md +++ b/scientific-skills/plotly/SKILL.md @@ -1,6 +1,6 @@ --- name: plotly -description: Interactive scientific and statistical data visualization library for Python. Use when creating charts, plots, or visualizations including scatter plots, line charts, bar charts, heatmaps, 3D plots, geographic maps, statistical distributions, financial charts, and dashboards. Supports both quick visualizations (Plotly Express) and fine-grained customization (graph objects). Outputs interactive HTML or static images (PNG, PDF, SVG). +description: Interactive visualization library. Use when you need hover info, zoom, pan, or web-embeddable charts. Best for dashboards, exploratory analysis, and presentations. For static publication figures use matplotlib or scientific-visualization. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/polars/SKILL.md b/scientific-skills/polars/SKILL.md index 0a01b19..65e5329 100644 --- a/scientific-skills/polars/SKILL.md +++ b/scientific-skills/polars/SKILL.md @@ -1,6 +1,6 @@ --- name: polars -description: "Fast DataFrame library (Apache Arrow). Select, filter, group_by, joins, lazy evaluation, CSV/Parquet I/O, expression API, for high-performance data analysis workflows." +description: Fast in-memory DataFrame library for datasets that fit in RAM. Use when pandas is too slow but data still fits in memory. Lazy evaluation, parallel execution, Apache Arrow backend. Best for 1-100GB datasets, ETL pipelines, faster pandas replacement. For larger-than-RAM data use dask or vaex. license: https://github.com/pola-rs/polars/blob/main/LICENSE metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/pufferlib/SKILL.md b/scientific-skills/pufferlib/SKILL.md index 75e5112..45a78e4 100644 --- a/scientific-skills/pufferlib/SKILL.md +++ b/scientific-skills/pufferlib/SKILL.md @@ -1,6 +1,6 @@ --- name: pufferlib -description: This skill should be used when working with reinforcement learning tasks including high-performance RL training, custom environment development, vectorized parallel simulation, multi-agent systems, or integration with existing RL environments (Gymnasium, PettingZoo, Atari, Procgen, etc.). Use this skill for implementing PPO training, creating PufferEnv environments, optimizing RL performance, or developing policies with CNNs/LSTMs. +description: High-performance reinforcement learning framework optimized for speed and scale. Use when you need fast parallel training, vectorized environments, multi-agent systems, or integration with game environments (Atari, Procgen, NetHack). Achieves 2-10x speedups over standard implementations. For quick prototyping or standard algorithm implementations with extensive documentation, use stable-baselines3 instead. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/pylabrobot/SKILL.md b/scientific-skills/pylabrobot/SKILL.md index 86f957c..a6f4a4e 100644 --- a/scientific-skills/pylabrobot/SKILL.md +++ b/scientific-skills/pylabrobot/SKILL.md @@ -1,6 +1,6 @@ --- name: pylabrobot -description: Laboratory automation toolkit for controlling liquid handlers, plate readers, pumps, heater shakers, incubators, centrifuges, and analytical equipment. Use this skill when automating laboratory workflows, programming liquid handling robots (Hamilton STAR, Opentrons OT-2, Tecan EVO), integrating lab equipment, managing deck layouts and resources (plates, tips, containers), reading plates, or creating reproducible laboratory protocols. Applicable for both simulated protocols and physical hardware control. +description: Vendor-agnostic lab automation framework. Use when controlling multiple equipment types (Hamilton, Tecan, Opentrons, plate readers, pumps) or needing unified programming across different vendors. Best for complex workflows, multi-vendor setups, simulation. For Opentrons-only protocols with official API, opentrons-integration may be simpler. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/pyopenms/SKILL.md b/scientific-skills/pyopenms/SKILL.md index c4c953e..fec2472 100644 --- a/scientific-skills/pyopenms/SKILL.md +++ b/scientific-skills/pyopenms/SKILL.md @@ -1,6 +1,6 @@ --- name: pyopenms -description: Python interface to OpenMS for mass spectrometry data analysis. Use for LC-MS/MS proteomics and metabolomics workflows including file handling (mzML, mzXML, mzTab, FASTA, pepXML, protXML, mzIdentML), signal processing, feature detection, peptide identification, and quantitative analysis. Apply when working with mass spectrometry data, analyzing proteomics experiments, or processing metabolomics datasets. +description: Complete mass spectrometry analysis platform. Use for proteomics workflows feature detection, peptide identification, protein quantification, and complex LC-MS/MS pipelines. Supports extensive file formats and algorithms. Best for proteomics, comprehensive MS data processing. For simple spectral comparison and metabolite ID use matchms. license: 3 clause BSD license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/qiskit/SKILL.md b/scientific-skills/qiskit/SKILL.md index 5433a06..7ae79cb 100644 --- a/scientific-skills/qiskit/SKILL.md +++ b/scientific-skills/qiskit/SKILL.md @@ -1,6 +1,6 @@ --- name: qiskit -description: Comprehensive quantum computing toolkit for building, optimizing, and executing quantum circuits. Use when working with quantum algorithms, simulations, or quantum hardware including (1) Building quantum circuits with gates and measurements, (2) Running quantum algorithms (VQE, QAOA, Grover), (3) Transpiling/optimizing circuits for hardware, (4) Executing on IBM Quantum or other providers, (5) Quantum chemistry and materials science, (6) Quantum machine learning, (7) Visualizing circuits and results, or (8) Any quantum computing development task. +description: IBM's quantum computing framework. Use when targeting IBM Quantum hardware, working with Qiskit Runtime for production workloads, or needing IBM's optimization tools. Best for IBM hardware execution, quantum error mitigation, and enterprise quantum computing. For Google hardware use cirq; for gradient-based quantum ML use pennylane; for open quantum system simulations use qutip. license: Apache-2.0 license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/qutip/SKILL.md b/scientific-skills/qutip/SKILL.md index fad711b..26c1da8 100644 --- a/scientific-skills/qutip/SKILL.md +++ b/scientific-skills/qutip/SKILL.md @@ -1,6 +1,6 @@ --- name: qutip -description: "Quantum mechanics simulations and analysis using QuTiP (Quantum Toolbox in Python). Use when working with quantum systems including: (1) quantum states (kets, bras, density matrices), (2) quantum operators and gates, (3) time evolution and dynamics (Schrödinger, master equations, Monte Carlo), (4) open quantum systems with dissipation, (5) quantum measurements and entanglement, (6) visualization (Bloch sphere, Wigner functions), (7) steady states and correlation functions, or (8) advanced methods (Floquet theory, HEOM, stochastic solvers). Handles both closed and open quantum systems across various domains including quantum optics, quantum computing, and condensed matter physics." +description: Quantum physics simulation library for open quantum systems. Use when studying master equations, Lindblad dynamics, decoherence, quantum optics, or cavity QED. Best for physics research, open system dynamics, and educational simulations. NOT for circuit-based quantum computing—use qiskit, cirq, or pennylane for quantum algorithms and hardware execution. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/scanpy/SKILL.md b/scientific-skills/scanpy/SKILL.md index 6bb322a..47fd5e3 100644 --- a/scientific-skills/scanpy/SKILL.md +++ b/scientific-skills/scanpy/SKILL.md @@ -1,6 +1,6 @@ --- name: scanpy -description: "Single-cell RNA-seq analysis. Load .h5ad/10X data, QC, normalization, PCA/UMAP/t-SNE, Leiden clustering, marker genes, cell type annotation, trajectory, for scRNA-seq analysis." +description: Standard single-cell RNA-seq analysis pipeline. Use for QC, normalization, dimensionality reduction (PCA/UMAP/t-SNE), clustering, differential expression, and visualization. Best for exploratory scRNA-seq analysis with established workflows. For deep learning models use scvi-tools; for data format questions use anndata. license: SD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/scientific-brainstorming/SKILL.md b/scientific-skills/scientific-brainstorming/SKILL.md index 3c2af70..f15f8d0 100644 --- a/scientific-skills/scientific-brainstorming/SKILL.md +++ b/scientific-skills/scientific-brainstorming/SKILL.md @@ -1,6 +1,6 @@ --- name: scientific-brainstorming -description: "Research ideation partner. Generate hypotheses, explore interdisciplinary connections, challenge assumptions, develop methodologies, identify research gaps, for creative scientific problem-solving." +description: Creative research ideation and exploration. Use for open-ended brainstorming sessions, exploring interdisciplinary connections, challenging assumptions, or identifying research gaps. Best for early-stage research planning when you don't have specific observations yet. For formulating testable hypotheses from data use hypothesis-generation. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/scientific-critical-thinking/SKILL.md b/scientific-skills/scientific-critical-thinking/SKILL.md index eb578b0..8445fbd 100644 --- a/scientific-skills/scientific-critical-thinking/SKILL.md +++ b/scientific-skills/scientific-critical-thinking/SKILL.md @@ -1,6 +1,6 @@ --- name: scientific-critical-thinking -description: "Evaluate research rigor. Assess methodology, experimental design, statistical validity, biases, confounding, evidence quality (GRADE, Cochrane ROB), for critical analysis of scientific claims." +description: Evaluate scientific claims and evidence quality. Use for assessing experimental design validity, identifying biases and confounders, applying evidence grading frameworks (GRADE, Cochrane Risk of Bias), or teaching critical analysis. Best for understanding evidence quality, identifying flaws. For formal peer review writing use peer-review. allowed-tools: [Read, Write, Edit, Bash] license: MIT license metadata: diff --git a/scientific-skills/scientific-visualization/SKILL.md b/scientific-skills/scientific-visualization/SKILL.md index 1dbaa0a..2630d66 100644 --- a/scientific-skills/scientific-visualization/SKILL.md +++ b/scientific-skills/scientific-visualization/SKILL.md @@ -1,6 +1,6 @@ --- name: scientific-visualization -description: "Create publication figures with matplotlib/seaborn/plotly. Multi-panel layouts, error bars, significance markers, colorblind-safe, export PDF/EPS/TIFF, for journal-ready scientific plots." +description: Meta-skill for publication-ready figures. Use when creating journal submission figures requiring multi-panel layouts, significance annotations, error bars, colorblind-safe palettes, and specific journal formatting (Nature, Science, Cell). Orchestrates matplotlib/seaborn/plotly with publication styles. For quick exploration use seaborn or plotly directly. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/scvi-tools/SKILL.md b/scientific-skills/scvi-tools/SKILL.md index 0c485c9..487a455 100644 --- a/scientific-skills/scvi-tools/SKILL.md +++ b/scientific-skills/scvi-tools/SKILL.md @@ -1,6 +1,6 @@ --- name: scvi-tools -description: This skill should be used when working with single-cell omics data analysis using scvi-tools, including scRNA-seq, scATAC-seq, CITE-seq, spatial transcriptomics, and other single-cell modalities. Use this skill for probabilistic modeling, batch correction, dimensionality reduction, differential expression, cell type annotation, multimodal integration, and spatial analysis tasks. +description: Deep generative models for single-cell omics. Use when you need probabilistic batch correction (scVI), transfer learning, differential expression with uncertainty, or multi-modal integration (TOTALVI, MultiVI). Best for advanced modeling, batch effects, multimodal data. For standard analysis pipelines use scanpy. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/seaborn/SKILL.md b/scientific-skills/seaborn/SKILL.md index ed43f62..74f9607 100644 --- a/scientific-skills/seaborn/SKILL.md +++ b/scientific-skills/seaborn/SKILL.md @@ -1,6 +1,6 @@ --- name: seaborn -description: "Statistical visualization. Scatter, box, violin, heatmaps, pair plots, regression, correlation matrices, KDE, faceted plots, for exploratory analysis and publication figures." +description: Statistical visualization with pandas integration. Use for quick exploration of distributions, relationships, and categorical comparisons with attractive defaults. Best for box plots, violin plots, pair plots, heatmaps. Built on matplotlib. For interactive plots use plotly; for publication styling use scientific-visualization. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/stable-baselines3/SKILL.md b/scientific-skills/stable-baselines3/SKILL.md index 13491e1..5473431 100644 --- a/scientific-skills/stable-baselines3/SKILL.md +++ b/scientific-skills/stable-baselines3/SKILL.md @@ -1,6 +1,6 @@ --- name: stable-baselines3 -description: Use this skill for reinforcement learning tasks including training RL agents (PPO, SAC, DQN, TD3, DDPG, A2C, etc.), creating custom Gym environments, implementing callbacks for monitoring and control, using vectorized environments for parallel training, and integrating with deep RL workflows. This skill should be used when users request RL algorithm implementation, agent training, environment design, or RL experimentation. +description: Production-ready reinforcement learning algorithms (PPO, SAC, DQN, TD3, DDPG, A2C) with scikit-learn-like API. Use for standard RL experiments, quick prototyping, and well-documented algorithm implementations. Best for single-agent RL with Gymnasium environments. For high-performance parallel training, multi-agent systems, or custom vectorized environments, use pufferlib instead. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/statistical-analysis/SKILL.md b/scientific-skills/statistical-analysis/SKILL.md index ac9b72a..e5a4a74 100644 --- a/scientific-skills/statistical-analysis/SKILL.md +++ b/scientific-skills/statistical-analysis/SKILL.md @@ -1,6 +1,6 @@ --- name: statistical-analysis -description: "Statistical analysis toolkit. Hypothesis tests (t-test, ANOVA, chi-square), regression, correlation, Bayesian stats, power analysis, assumption checks, APA reporting, for academic research." +description: Guided statistical analysis with test selection and reporting. Use when you need help choosing appropriate tests for your data, assumption checking, power analysis, and APA-formatted results. Best for academic research reporting, test selection guidance. For implementing specific models programmatically use statsmodels. license: MIT license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/statsmodels/SKILL.md b/scientific-skills/statsmodels/SKILL.md index 9a2aa9a..23a9ea2 100644 --- a/scientific-skills/statsmodels/SKILL.md +++ b/scientific-skills/statsmodels/SKILL.md @@ -1,6 +1,6 @@ --- name: statsmodels -description: "Statistical modeling toolkit. OLS, GLM, logistic, ARIMA, time series, hypothesis tests, diagnostics, AIC/BIC, for rigorous statistical inference and econometric analysis." +description: Statistical models library for Python. Use when you need specific model classes (OLS, GLM, mixed models, ARIMA) with detailed diagnostics, residuals, and inference. Best for econometrics, time series, rigorous inference with coefficient tables. For guided statistical test selection with APA reporting use statistical-analysis. license: BSD-3-Clause license metadata: skill-author: K-Dense Inc. diff --git a/scientific-skills/torchdrug/SKILL.md b/scientific-skills/torchdrug/SKILL.md index 5f0d6a1..a6db783 100644 --- a/scientific-skills/torchdrug/SKILL.md +++ b/scientific-skills/torchdrug/SKILL.md @@ -1,6 +1,6 @@ --- name: torchdrug -description: "Graph-based drug discovery toolkit. Molecular property prediction (ADMET), protein modeling, knowledge graph reasoning, molecular generation, retrosynthesis, GNNs (GIN, GAT, SchNet), 40+ datasets, for PyTorch-based ML on molecules, proteins, and biomedical graphs." +description: PyTorch-native graph neural networks for molecules and proteins. Use when building custom GNN architectures for drug discovery, protein modeling, or knowledge graph reasoning. Best for custom model development, protein property prediction, retrosynthesis. For pre-trained models and diverse featurizers use deepchem; for benchmark datasets use pytdc. license: Apache-2.0 license metadata: skill-author: K-Dense Inc.