<> <> = Referencing = {{{#!wiki references Warrington S*, Thompson E*, Bastiani M, Dubois J, Baxter L, Slater R, Jbabdi S, Mars RB, Sotiropoulos SN (2022) Concurrent mapping of brain ontogeny and phylogeny within a common space: Standardzed tractography and applications. Science Advances, 8(42). [[https://science.org/doi/10.1126/sciadv.abq2022|DOI: 10.1126/sciadv.abq2022]] }}} {{{#!wiki references Warrington S, Bryant K, Khrapitchev A, Sallet J, Charquero-Ballester M, Douaud G, Jbabdi S*, Mars R*, Sotiropoulos SN* (2020) XTRACT - Standardised protocols for automated tractography and connectivity blueprints in the human and macaque brain. NeuroImage, 217(116923). [[https://doi.org/10.1016/j.neuroimage.2020.116923|DOI: 10.1016/j.neuroimage.2020.116923]] }}} {{{#!wiki references de Groot M; Vernooij MW. Klein S, Ikram MA, Vos FM, Smith SM, Niessen WJ, Andersson JLR (2013) Improving alignment in Tract-based spatial statistics: Evaluation and optimization of image registration. NeuroImage, 76(1), 400-411. [[https://doi.org/10.1016/j.neuroimage.2013.03.015|DOI: 10.1016/j.neuroimage.2013.03.015]] }}} ----- = XTRACT - a command-line tool for automated tractography = XTRACT (cross-species tractography) can be used to automatically extract a set of carefully dissected tracts in human (neonates and adults) and macaques. It can also be used to define one's own tractography protocols where all the user needs to do is to define a set of masks in standard space (e.g. MNI152). XTRACT reads the standard space protocols and performs probabilistic tractography ([[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#PROBTRACKX_-_probabilistic_tracking_with_crossing_fibres|probtrackx2]]) in the subject's native space. Resultant tracts may be stored in either the subject's native space or in standard space. The user must provide the crossing fibres fitted data ([[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#BEDPOSTX|bedpostx]]) and diffusion to standard space [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#Registration_within_FDT|registration]] warp fields (and their inverse). XTRACT atlases are available within FSLeyes or can be downloaded [[https://github.com/SPMIC-UoN/XTRACT_atlases|here]]. {{attachment:xtract_wiki_tracts.png|Homologous tracts in the adult and neonate human, and the macaque|width="750"}} ---- == Usage == {{{ __ _______ ____ _ ____ _____ \ \/ /_ _| _ \ / \ / ___|_ _| \ / | | | |_) | / _ \| | | | / \ | | | _ < / ___ \ |___ | | /_/\_\ |_| |_| \_\/_/ \_\____| |_| Usage: xtract -bpx -out -species [options] xtract -bpx -out -species CUSTOM -str -p -stdref [options] xtract -list Compulsory arguments: -bpx Path to bedpostx folder -out Path to output folder -species One of HUMAN or MACAQUE or HUMAN_BABY or CUSTOM If -species CUSTOM: -str Structures file (format: format: [samples=1], 1 means 1000, '#' to skip lines) -p Protocols folder (all masks in same standard space) -stdref Standard space reference image Optional arguments: -list List the tract names used in XTRACT -str Structures file (format: per line OR format: [samples=1], 1 means 1000, '#' to skip lines) -p Protocols folder (all masks in same standard space) (Default=/Users/shaunwarrington/fsl/data/xtract_data/) -stdwarp Non-linear Standard2diff and Diff2standard transforms (Default=bedpostx_dir/xfms/{standard2diff.nii.gz,diff2standard.nii.gz}) -stdref Standard space reference image (Default = /Users/shaunwarrington/fsl/data/standard/MNI152_T1_1mm [HUMAN], /Users/shaunwarrington/fsl/data/xtract_data/standard/F99/mri/struct_brain [MACAQUE], /Users/shaunwarrington/fsl/data/xtract_data/standard/neonate/schuh_template [HUMAN_BABY]) -gpu Use GPU version -par If cluster, run in parallel: submit 1 job per tract -res Output resolution (Default=same as in protocol folders unless '-native' used) -ptx_options Pass extra probtrackx2 options as a text file to override defaults, e.g. --steplength=0.2 --distthresh=10) And EITHER: -native Run tractography in native (diffusion) space OR: -ref Reference image for running tractography in reference space, Diff2Reference and Reference2Diff transforms }}} ---- == Running XTRACT == XTRACT automatically detects if $SGE_ROOT is set and if so uses FSL_SUB. For optimal performance, use the GPU version!!!! '''Outputs of XTRACT''' Under : * "commands.txt" - XTRACT processing commands * "logs" - directory containing the probtrackx log files * "tracts" - directory continaing tractography results * "" - directory per tract, each continaing: * "waytotal" - txt file continaing the number of valid streamlines * "density.nii.gz" - nifti file containing the fibre probability distribution * "density_lenths.nii.gz" - nifti file containing the fibre lengths, i.e. each voxel is the average streamline length - this is the "-ompl" probtrackx option * "densityNorm.nii.gz" - nifti file continaing the waytotal normalised fibre probability distribution (the "density.nii.gz" divided by the total number of valid streamlines) * if the protocol calls for reverse-seeding: * "tractsInv" - directory continaing the above for the seed-target reversed run * "sum_waytotal" and "sum_density.nii.gz" - the summed waytotal and fibre probability distribution If the "-native" option is being used: * "masks" - directory * "" - directory per tract continaing the native space protocol masks '''The primary output is the "densityNorm.nii.gz" file.''' '''Pre-processing''' Prior to running XTRACT, you must complete the [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#Processing_pipeline|FDT processing pipeline]]: 1. Brain extraction using [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/BET|BET]] 1. Susceptibility distortion correction using [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/topup|topup]] (only if spin-echo fieldmaps have been acquired - if you don't have these, skip to step 3) 1. Eddy current distortion and motion correction using [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/eddy|eddy]] 1. Fit the crossing fibre model using [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#BEDPOSTX|bedpostx]] 1. Non-linear registration to standard space (MNI152 for adult human, F99 for macaque), see the [[https://fsl.fmrib.ox.ac.uk/fsl/fslwiki/FDT/UserGuide#Registration_within_FDT|FDT pipeline]] Your data should now be ready to run XTRACT! Note on ANTs warp fields: to use these fields, you must convert the warp fields to FSL's FNIRT convention. We provide a script to do so [[https://github.com/SPMIC-UoN/usefultools/blob/master/ants2fnirt.sh|here]]. ---- == Standard Spaces == * For HUMAN, XTRACT uses the MNI152 standard space in $FSLDIR/etc/standard * For MACAQUE, XTRACT uses the F99 atlas in Caret - see http://brainvis.wustl.edu/wiki/index.php/Caret:Atlases . We also provide a copy of the F99 atlas in $FSLDIR/etc/xtract_data/standard/F99. This includes a helper script for registering your own diffusion/structural data to the F99 altas When running XTRACT with the '-species' option, a predefined list of tracts is automatically extracted. Currently the following tracts are available: ||'''Tract''' ||'''Abbreviation''' || ||Arcuate Fasciculus ||AF || ||Acoustic Radiation ||AR || ||Anterior Thalamic Radiation ||ATR || ||Cingulum subsection : Dorsal ||CBD || ||Cingulum subsection : Peri-genual ||CBP || ||Cingulum subsection : Temporal ||CBT || ||Corticospinal Tract ||CST || ||Frontal Aslant ||FA || ||Forceps Major ||FMA || ||Forceps Minor ||FMI || ||Fornix ||FX || ||Inferior Longitudinal Fasciculus ||ILF || ||Inferior Fronto-Occipital Fasciculus ||IFO || ||Middle Cerebellar Peduncle ||MCP || ||Middle Longitudinal Fasciculuc ||MdLF || ||Optic Radiation ||OR || ||Superior Thalamic Radiation ||STR || ||Superior Longitudinal Fasciculus 1 ||SLF1 || ||Superior Longitudinal Fasciculus 2 ||SLF2 || ||Superior Longitudinal Fasciculus 3 ||SLF3 || ||Anterior Commissure ||AC || ||Uncinate Fasciculus ||UF || ||Vertical Occipital Fasciculus ||VOF || ---- == External Compatible Protocol Libraries == Additional tractography protocols, compatible with XTRACT, are available for other species and brains. * Chimpanzee: Bryant et al. (2020) A comprehensive atlas of white matter tracts in the chimpanzee. [[https://doi.org/10.1371/journal.pbio.3000971|PLoS Biol 18(12): e3000971]] * Pig: Benn et al. (2020) A Pig White Matter Atlas and Common Connectivity Space Provide a Roadmap for the Introduction of a New Animal Model in Translational Neuroscience [[https://doi.org/10.1101/2020.10.13.337436|bioRxiv]] * 8 non-human primate species: Bryant et al. (2021) Diffusion MRI data, sulcal anatomy, and tractography for eight species from the Primate Brain Bank. [[https://doi.org/10.1007/s00429-021-02268-x|Brain Structure and Function]] * Macaque, Gorilla, Chimpanzee, Human: Roumazeilles et al. (2020) Longitudinal connections and the organization of the temporal cortex in macaques, great apes, and humans. [[https://doi.org/10.1371/journal.pbio.3000810|PLOS Biology]] To implement external libraries: 1. download the protocols and standard space from the relevant publication, 1. build a structure list (` ` per line), 1. follow the pre-processing steps described above to obtain warp fields between the native diffusion space and the relevant standard space (the space in which the protocols are defined), 1. call XTRACT using the `-species CUSTOM` argument, specifying the standard space reference, the protocols directory and the structure list file (available in '''FSL 6.0.5+''') ---- == Adding your own tracts == Suppose you want to create an automated protocol for a tract called 'mytrack'. First you need to create a folder called 'mytrack' which you can add e.g. in the protocols folder. Then create the following NIFTI files (with this exact naming) and copy them into mytrack: '''Compulsory''': * seed.nii.gz : a seed mask '''Optional''': * stop.nii.gz : a stop mask if required * exclude.nii.gz : an exclusion mask if required * ONE of the following: * target.nii.gz : a single target mask * target1.nii.gz, target2.nii.gz, etc. : a number of targets, in which case streamlines will be kept if they cross ALL of them * invert (empty file to indicate that a seed->target and target->seed run will be added and combined) . if such an option is required a single "target.nii.gz" file is also expected All the masks above should be in standard space (e.g. MNI152 or F99) if you want to run the same tracking for a collection of subjects. Next, make a structure file using the format ` ` per line and call XTRACT using `-species -str -p `, pointing to your new protocols folder 'mytrack'. ----- = XTRACT Atlases = 42 probabilistic tract atlases were derived using 1021 subjects from the Human Connectome Project as described in Warrington et al. (2020) NeuroImage. In brief, XTRACT was applied to each subject’s minimally preprocessed diffusion MRI data (Glasser et al, Neuroimage 2013 - Sotiropoulos et al, Neuroimage 2013). The subsequent tract estimates were binarised at a threshold and averaged across the cohort, providing population percent overlap maps for each of the major white matter fibre bundles. Data were provided by the Human Connectome Project, WU-Minn Consortium (Principal Investigators: David Van Essen and Kamil Ugurbil; 1U54MH091657) funded by the 16 NIH Institutes and Centers that support the NIH Blueprint for Neuroscience Research; and by the McDonnell Center for Systems Neuroscience at Washington University. We also include equivalent tract atlases for the macaque brain. These atlases are available within FSLeyes or can be downloaded [[https://github.com/SPMIC-UoN/XTRACT_atlases|here]]. Citation: Warrington S, Bryant K, Khrapitchev A, Sallet J, Charquero-Ballester M, Douaud G, Jbabdi S*, Mars R*, Sotiropoulos SN* (2020) XTRACT - Standardised protocols for automated tractography and connectivity blueprints in the human and macaque brain. NeuroImage. DOI: 10.1016/j.neuroimage.2020.116923 ----- = Generating Connectivity Blueprints with xtract_blueprint = xtract_blueprint is a flexible yet simple way to calculate the "connectivity blueprint" (Mars et al. 2018 eLife, Warrington et al. 2020 NeuroImage): a vertex (or voxel) by tract matrix where each row describes how each (sub)cortical location is connected to major white matter fibre bundles, and each column describes the (sub)cortical terminations of each of the white matter fibre bundles. xtract_blueprint can, in principle, build a connectivity blueprint for any brain (e.g. different species), at any resolution (i.e. number of vertices) and for any region (whole whole or a given ROI, a lobe for example), including the subcortex. The script was written by Shaun Warrington (University of Nottingham), Saad Jbabdi (Oxford University) and Stamatios Sotiropoulos (University of Nottingham). {{attachment:xtract_blueprint.png|Connectivity Blueprints|width="750"}} ---- == Citations == {{{#!wiki references Warrington S*, Thompson E*, Bastiani M, Dubois J, Baxter L, Slater R, Jbabdi S, Mars RB, Sotiropoulos SN (2022) Concurrent mapping of brain ontogeny and phylogeny within a common space: Standardzed tractography and applications. Science Advances, 8(42). [[https://science.org/doi/10.1126/sciadv.abq2022|DOI: 10.1126/sciadv.abq2022]] }}} {{{#!wiki references Mars R, Sotiropoulos SN, Passingham RE, Sallet J, Verhagen L, Khrapitchev AA, Sibson N, Jbabdi S (2018) Whole brain comparative anatomy using connectivity blueprints. eLife. DOI: 10.7554/eLife.35237 }}} {{{#!wiki references Warrington S, Bryant K, Khrapitchev A, Sallet J, Charquero-Ballester M, Douaud G, Jbabdi S*, Mars R*, Sotiropoulos SN* (2020) XTRACT - Standardised protocols for automated tractography in the human and macaque brain. NeuroImage. DOI: 10.1016/j.neuroimage.2020.116923 }}} ---- {{{ __ _______ ____ _ ____ _____ _ _ _ _ \ \/ /_ _| _ \ / \ / ___|_ _| |__ | |_ _ ___ _ __ _ __(_)_ __ | |_ \ / | | | |_) | / _ \| | | | | '_ \| | | | |/ _ \ '_ \| '__| | '_ \| __| / \ | | | _ < / ___ \ |___ | | | |_) | | |_| | __/ |_) | | | | | | | |_ /_/\_\ |_| |_| \_\/_/ \_\____| |_| |_.__/|_|\__,_|\___| .__/|_| |_|_| |_|\__| |_| Usage: xtract_blueprint -bpx -out -xtract -seeds [options] Compulsory arguments: -bpx Path to bedpostx folder -out Path to output folder -xtract Path to xtract folder -seeds Comma separated list of seeds for which a blueprint is requested (e.g. left and right cortex in standard space) -warps Standard space reference image, and transforms between xtract space and diffusion space -target A whole brain/WM binary target mask in the same space as the seeds Optional arguments: -stage What to run. 1:matrix2, 2:blueprint, all:everythng (default) -gpu Use GPU version -savetxt Save blueprint as txt file (nseed by ntracts) instead of CIFTI -prefix Specify a prefix for the final blueprint filename (e.g. _BP.LR.dscalar.nii) -rois Comma separated list (1 per seed): ROIs (gifti) to restrict seeding (e.g. medial wall masks) -stops Text file containing line separated list of stop masks (see probtrackx usage for details) -wtstops Text file containing line separated list of wtstop masks (see probtrackx usage for details) -subseed Binary NIFTI image for subcortical seeding - to generate a surface+volume CIFTI -tract_list Comma separated list of tracts to include (default = all found under -xtract ) -thr Threshold applied to XTRACT tracts prior to blueprint calculation (default = 0.001, i.e. 0.1% probability). -nsamples Number of samples per seed used in tractography (default = 1000) -res Resolution of matrix2 output (Default = 3 mm) -ptx_options Pass extra probtrackx2 options as a text file to override defaults Example usage: xtract_blueprint -bpx -out -xtract -seeds \ -rois -warps -gpu }}} ---- == Running xtract_blueprint == In order to use xtract_blueprint, you need to have run xtract first. To construct the connectivity blueprints, xtract_blueprint expects the same warp fields as used in the running of xtract. xtract_blueprint supports the construction of connectivity blueprints using surface (GIFTI) or volume (NIFTI) files. Surface or volume files may be used for the cortical (white-grey matter boundary) seed. Volume files are required for subcortical seeds. If a volume file is used as the cortical seed, the resultant output will be a 4D NIFTI blueprint. For surface data, the resultant output will be a dscalar CIFTI. Required input: * bedpostx folder - crossing fibre modelled diffusion data (expects to find nodif_brain_mask) * xtract folder - xtract tract folder (the output from xtract) * seed - the comma separated seed masks to use in tractography (e.g. the white-grey matter boundary surfaces), e.g. `L.white.surf.gii,R.white.surf.gii` * warps - a reference standard space image and warps to and from the native diffusion and standard spaces, e.g. `MNI152.nii.gz standard2diff.nii.gz diff2standard.nii.gz` * target - a whole-brain white matter target NIFTI mask (resolution of this target is set by the `'-res'` flag) Note: if running whole-brain (recommended), you must provide the left seed first, as exampled. We also recommend that you use a medial wall mask to restrict the blueprint to the GM surface. Running modes: * Stage 1 only - only run seed-based tractography * Stage 2 only - only run blueprint processing (requires xtract output and tractography from stage 1) * All - runs both stage 1 and stage 2 processing xtract_blueprint is capable of GPU acceleration (`'-gpu'` flag) and works with fsl_sub to submit jobs in parallel. If using the CPU version, expect tractography to take many hours - you can speed this up by using a lower resolution seed and/or target. '''Tractography details and options:''' Tractography is performed for each seed region separately. The resultant connectivity matrices (fdt_matrix) are stacked in order to construct a whole-brain connectivity blueprint. You may also provide a single hemisphere if you wish. Optionally, you may also provide stop (stop tracking at locations given by this mask file) and wtstop (allow propagation within mask but terminate on exit) masks. Stop is typically the pial surface. wtstop is typically subcortical structures and/or the white surface. These should be specified as line separated text files. e.g. `-seeds -stop stop.txt -wtstop wtstop.txt` Spatial resolution: by default tractography will be ran and stored using a resolution of 3 mm for the target. This may be adjusted using the `'-res'` argument. Note: if required, xtract_blueprint will resample the xtract tracts. Warning: connectivity matrices are very large and require a lot of memory to handle - 3 mm is usually sufficient for the adult human brain. Additional probtrackx options may also be supplied. Simply add the probtrackx arguments to a text file and direct xtract_blueprint to this using the `'-ptx_options'` argument. Connectivity blueprints are primarily concerned with the connectivity of the cortex to white matter tracts. As such, we offer the option the mask out the medial wall. To do so, provide a single medial wall mask per supplied seed: e.g. `-seeds l.white.surf.gii,r.white.surf.gii -rois l.roi,r.roi`. By default, the medial wall is included in the calculation of the connectivity blueprint: we recommend the use of the medial wall mask to prevent this. The '-roi' argument may be used to restrict the blueprint to any region of interest, not just to exclude the medial wall. For example, you may provide an ROI restricting the blueprint to the temporal or frontal lobe. If you wish to use a stop/wtstop surface mask, you must ensure that the number of vertices matches the seed mask. This means that, if you are providing a seed mask and medial wall mask to xtract_blueprint, and wish to provide a surface stop mask, you must convert the stop mask to asc, restricting the data points to the medial wall mask, e.g.: {{{ ${FSLDIR}/bin/surf2surf -i stop.L.surf.gii -o stop.L.asc --outputtype=ASCII --values=l.roi.shape.gii ${FSLDIR}/bin/surf2surf -i stop.R.surf.gii -o stop.R.asc --outputtype=ASCII --values=r.roi.shape.gii }}} Then supply "stop.L.asc" and "stop.R.asc" in a text file to xtract_blueprint using the `'-stop'` argument. This conversion is automatically performed for the seed mask in xtract_blueprint if a medial wall mask is supplied. Subcortical seeding has now been introduced and may be used with the `'-subcort'` flag. The input when performing subcortical seeding is a single NIFTI file containing the subcortex of interest. Future versions will include a subcortex structure-wise option. '''Which tracts are included?''' Connectivity blueprints may be constructed using the provided XTRACT tracts or using your own. By default, xtract_blueprint will use all tracts it finds under the xtract folder. You can specify a subset, or you own tracts, by providing a comma separated list of tracts using the `'-tracts '` argument. Certain tracts, e.g. the Middle Cerebellar Peduncle (MCP), do not project to the cortex. As such, they should be disregarded when interpreting the connectivity blueprint, or excluded from its construction. '''Only interested in the connectivity of a specific area?''' In many cases, the connectivity to a particular lobe, e.g. temporal or frontal, is of interest. You can use xtract_blueprint to obtain a connectivity blueprint for such a region: 1. Define a binary mask which contains the region of interest as a shape.gii or func.gii file 1. Select the tracts of interest: in all likelihood, only a subset of XTRACT's tracts will project to the ROI 1. Supply the whole white matter surface file along with the ROI to xtract_blueprint, e.g. for the temporal lobe {{{ xtract_blueprint -bpx sub001/dMRI.bedpostx -out sub001/blueprint -xtract sub001/xtract \ -warps MNI152_brain.nii.gz sub001/xtract2diff.nii.gz sub001/diff2xtract.nii.gz -gpu \ -seeds sub001/l.white.surf.gii -rois sub001/l.temporal_lobe.shape.gii \ -tract_list af_l,ilf_l,ifo_l,mdlf_l,slf3_l }}} ---- == Outputs of xtract_blueprint == xtract_blueprint will create an output directory specified by the `'-out'` argument. This will contain any log and command files along with a sub-directory per seed. Each sub-directory contains the resultant connectivity matrix from stage 1. The connectivity blueprint will be saved in the parent output directory (a CIFTI dscalar.nii file). Under outputDir: * Stage 1 (matrix2 tractography) output * omatrix2: * "ptx_commands.txt" - the probtrackx commands for tractography * "``" - sub-directory containing tractography results for each seed supplied, each containing: * "coords_fdt_matrix2" - the coordinates of the seed mask * "lookup_tractspace_fdt_matrix.nii.gz" - the target lookup space * "tract_space_coords_for_fdt_matrix2" - the coordinates of the target mask * "probtrackx.log" - the probtrackx log file * "fdt_paths.nii.gz" - a NIFTI file containing the generated streamlines * "fdt_matrix.dot" - the sparse format connectivity matrix (used to calculated the blueprint) * "waytotal" - txt file continaing the number of valid streamlines * Stage 2 (blueprint calculation) output * "bp_commands.txt" - the blueprint calculation commands * "BP.``.dscalar.nii" - CIFTI file containing the whole-brain connectivity blueprint - if running both hemispheres * "logs" - sub-directory containing job scheduler log files for both stages Alternatively, the `'-savetxt'` option may be used to override this. In this case, two txt files will be saved: the first (BP.``.txt) will be an n_seed by n_tracts array containing the blueprint; the second (tract_order.``.txt) is an n_tracts by 1 array containing the tract order in which the blueprint is structured. Note: no CIFTI file will be generated. If a volume seed is provided, xtract_blueprint will generate a volume-space blueprint as a 4D NIFTI file. ----- = Visualising results in FSLEYES with xtract_viewer = The output of XTRACT is a folder that contains tracts in separate folders. We provide a convenient script ("xtract_viewer") that can load these tracts (or a subset of the tracts) into FSLEYES using different colours for the different tracts but matching the left/right colours. Notice that in the '''FSL 6.0.2 release''', "xtract_viewer" has not been included into the main $FSLDIR/bin path of executables, therefore it needs to be manually launched from ''$FSLDIR/src/xtract/xtract_viewer'' This has been corrected in '''FSL 6.0.3+ ''' {{{ __ _______ ____ _ ____ _____ _ \ \/ /_ _| _ \ / \ / ___|_ _| __ _(_) _____ _____ _ __ \ / | | | |_) | / _ \| | | | \ \ / / |/ _ \ \ /\ / / _ \ '__| / \ | | | _ < / ___ \ |___ | | \ V /| | __/\ V V / __/ | /_/\_\ |_| |_| \_\/_/ \_\____| |_| \_/ |_|\___| \_/\_/ \___|_| Usage: xtract_viewer -dir -species HUMAN [options] xtract_viewer -dir -species MACAQUE [options] xtract_viewer -dir -brain [options] Compulsory arguments: -dir Path to XTRACT output folder And EITHER: -species One of HUMAN or MACAQUE OR: -brain The brain image to use for the background overlay - must be in the same space as tracts. Default is the FSL_HCP065_FA map for HUMAN and F99 T1 brain for MACAQUE Optional arguments: -str STRUCTURE,STRUCTURE,... Structures (comma separated (default = display all found in input folder) -thr NUMBER NUMBER The lower and upper thresholds applied to the tracts for viewing Default = 0.001 0.1 }}} ----- = Extracting tract-wise summary statistics with xtract_stats = A common usage of the XTRACT output is to summarise tracts in terms of simple summary statistics, such as their volume and microstructural properties (e.g. mean FA). We provide XTRACT_stats to get such summary statistics in a quick and simple way. You can use XTRACT stats with any modelled diffusion data, e.g. DTI, bedpostx, DKI. Simply provide; the directory (and basename of files, if any) leading to the diffusion data of interest, the directory containing the XTRACT output, the warp field (or use 'native' if tracts are already in diffusion space). If tracts are not in diffusion space, you must also provide a reference image in diffusion space (e.g. FA map). e.g. call to summarise default statistics: {{{ xtract_stats -d /home/DTI/dti_ -xtract /home/xtract -w /home/warp/standard2diff -r /home/DTI/dti_FA` }}} The output (a .csv file) by default contains the tract volume (mm3) and the mean, median and standard deviation of the probability, length, FA and MD for each tract. e.g. call for crossing fibre features and tract volume: {{{ xtract_stats -d /home/DTI.bedpostX/mean_ -xtract /home/xtract -w /home/warp/standard2diff -r /home/DTI/dti_FA -meas vol,f1samples,f2samples }}} This call would result in a .csv file containing the tract volume and the mean, median and standard deviation of `mean_f1samples` and `mean_f2samples` for each tract. {{{ __ _______ ____ _ ____ _____ _ _ \ \/ /_ _| _ \ / \ / ___|_ _|__| |_ __ _| |_ ___ \ / | | | |_) | / _ \| | | |/ __| __/ _ | __/ __| / \ | | | _ < / ___ \ |___ | |\__ \ || (_| | |_\__ \ /_/\_\ |_| |_| \_\/_/ \_\____| |_||___/\__\__ _|\__|___/ Usage: xtract_stats -d -xtract -w [options] Compulsory arguments: -d Path to microstructure folder and basename of data (e.g. /home/DTI/dti_) -xtract Path to XTRACT output folder -w EITHER XTRACT results to diffusion space transform OR 'native' if tracts are already in diffusion space Optional arguments: -r If not 'native', provide reference image in diffusion space (e.g. /home/DTI/dti_FA) -out Output filepath (Default /stats.csv) -str Structures file (as in XTRACT) (Default is all tracts under ) -thr Threshold applied to tract probability map (default = 0.001 = 0.1%) -meas Comma separated list of features to extract (Default = vol,prob,length,FA,MD - assumes DTI folder has been provided) vol = tract volume, prob = tract probability, length = tract length Additional metrics must follow file naming conventions. e.g. for dti_L1 use 'L1' -keepfiles Keep temporary files }}} ----- = Performing quality control (QC) with xtract_qc = We provide xtract_qc for a simple way to find failed XTRACT runs and potential outliers. The script was written by Shaun Warrington. {{{ __ _______ ____ _ ____ _____ ___ ____ \ \/ /_ _| _ \ / \ / ___|_ _/ _ \ / ___| \ / | | | |_) | / _ \| | | || | | | | / \ | | | _ < / ___ \ |___ | || |_| | |___ /_/\_\ |_| |_| \_\/_/ \_\____| |_| \__\_\____| Usage: xtract_qc -subject_list -out [options] Compulsory arguments: -subject_list Text file containing line separated subject-wise paths to XTRACT folders -out Path to output folder -tract_list Comma separated list of tracts to include (default = the XTRACT 'HUMAN' structureList ) Optional arguments: -thr Threshold applied to XTRACT tracts for volume calculation (default = 0.001, i.e. 0.1% probability). -n_std The number of standard deviations (either side of mean) to allow before being flagged as an outlier (default = 2). -use_prior If already run xtract_qc, use previously created metrics (default = create new metrics and overwrite) }}} == Running xtract_qc == xtract_qc is designed to work at the group level, identifying outliers by comparison to the group mean metrics. Therefore, a cohort of xtract results are expected. '''Input''' Minimally, xtract_qc requires a subject list and an output directory. The subject list should contain N subject lines where each line is the path to a subject's XTRACT results directory. e.g. /data/sub-001/xtract /data/sub-002/xtract /data/sub-003/xtract xtract_qc will then search for the tract results in each subject results directory. '''Output''' The primary output of xtract_qc is an html file, which should be opened using a browser. This html report contains a quick summary of the cohort and suggests potential outliers (outliers are tracts, rather than subjects) based on the recorded waytotal (i.e. number of valid streamlines generated during XTRACT) and the tract volume. The report also provides a breakdown of the number of potential outliers per tract and stores potential outliers as a .csv file.