diff --git a/examples/plot_custom_colors.py b/examples/plot_custom_colors.py index db47fbf..9195149 100644 --- a/examples/plot_custom_colors.py +++ b/examples/plot_custom_colors.py @@ -74,3 +74,28 @@ def norm(x): actor = tvtk.Actor() actor.mapper = mapper fig.scene.add_actor(actor) + +# 5) project rgba matrix to flat cortex patch: +fig = mlab.figure() +b2 = Brain('fsaverage', hemi, 'cortex.patch.flat', subjects_dir=subjects_dir, + background='white', figure=fig) +print('original rgba_vals.shape:',rgba_vals.shape) +rgba_vals=b2.geo[hemi].surf_to_patch_array(rgba_vals) +print('patch-compatible rgba_vals.shape:',rgba_vals.shape) + +# these are the patch's vertices coordinates +x, y, z = b2.geo[hemi].coords.T +tris = b2.geo[hemi].faces + +# plot points in x,y,z +mesh = mlab.pipeline.triangular_mesh_source( + x, y, z, tris, figure=fig) +mesh.data.point_data.scalars.number_of_components = 4 # r, g, b, a +mesh.data.point_data.scalars = (rgba_vals * 255).astype('ubyte') + +# tvtk for vis +mapper = tvtk.PolyDataMapper() +configure_input_data(mapper, mesh.data) +actor = tvtk.Actor() +actor.mapper = mapper +fig.scene.add_actor(actor) diff --git a/examples/plot_flatmap.py b/examples/plot_flatmap.py new file mode 100644 index 0000000..2b28f33 --- /dev/null +++ b/examples/plot_flatmap.py @@ -0,0 +1,26 @@ +#!/usr/bin/env python3 +# -*- coding: utf-8 -*- +""" +Flat patch demo. +""" + +from surfer import Brain +from mayavi import mlab + +print(__doc__) + +fig = mlab.figure(size=(1000,550)) + +brain = Brain("fsaverage", "both", "cortex.patch.flat", + subjects_dir='/usr/local/freesurfer/subjects', + figure=fig,background='w') +brain.add_label(label='V1_exvivo',hemi='lh') +brain.add_label(label='V1_exvivo',hemi='rh') + +overlay_file = "example_data/lh.sig.nii.gz" +brain.add_overlay(overlay_file,hemi='lh') + +cam = fig.scene.camera +cam.zoom(1.85) + +mlab.savefig('test.png',figure=fig,magnification=5) # save a high-res figure \ No newline at end of file diff --git a/examples/plot_fmri_activation_volume.py b/examples/plot_fmri_activation_volume.py index 6af35bb..ccfdd3a 100644 --- a/examples/plot_fmri_activation_volume.py +++ b/examples/plot_fmri_activation_volume.py @@ -76,5 +76,5 @@ mask = ~mask brain.add_data(mask, min=0, max=10, thresh=.5, colormap="bone", alpha=.6, colorbar=False) - -brain.show_view("medial") +if not hasattr(brain,'patch_mode'): + brain.show_view("medial") diff --git a/examples/plot_freesurfer_normalization.py b/examples/plot_freesurfer_normalization.py index 02589f5..90f574c 100644 --- a/examples/plot_freesurfer_normalization.py +++ b/examples/plot_freesurfer_normalization.py @@ -34,4 +34,5 @@ line_width=3, hemi=hemi) brain.contour_list[-1]["colorbar"].visible = False -brain.show_view("dorsal") +if not brain.patch_mode: + brain.show_view("dorsal") diff --git a/examples/plot_label.py b/examples/plot_label.py index 8083347..980641c 100644 --- a/examples/plot_label.py +++ b/examples/plot_label.py @@ -39,9 +39,9 @@ brain.add_label("BA6_exvivo", alpha=.7) # Finally, you can plot the label in any color you want. -brain.show_view(dict(azimuth=-42, elevation=105, distance=225, - focalpoint=[-30, -20, 15])) - +if not brain.patch_mode: + brain.show_view(dict(azimuth=-42, elevation=105, distance=225, + focalpoint=[-30, -20, 15])) # Use any valid matplotlib color. brain.add_label("V1_exvivo", color="steelblue", alpha=.6) brain.add_label("V2_exvivo", color="#FF6347", alpha=.6) diff --git a/examples/plot_label_foci.py b/examples/plot_label_foci.py index 092ba7e..f29f12f 100644 --- a/examples/plot_label_foci.py +++ b/examples/plot_label_foci.py @@ -63,4 +63,5 @@ """ Set the camera position to show the extent of the labels. """ -brain.show_view(dict(elevation=40, distance=0.430)) +if not brain.patch_mode: + brain.show_view(dict(elevation=40, distance=0.430)) diff --git a/examples/plot_morphometry.py b/examples/plot_morphometry.py index 6f6c46c..be9f1ba 100644 --- a/examples/plot_morphometry.py +++ b/examples/plot_morphometry.py @@ -10,9 +10,12 @@ print(__doc__) -brain = Brain("fsaverage", "both", "pial", views="frontal", +brain = Brain("fsaverage", "both", "pial", background="dimgray") +if not brain.patch_mode: + brain.show_view("frontal") + """ Because the morphometry files generated by recon-all live in a predicatble location, diff --git a/examples/plot_parcellation.py b/examples/plot_parcellation.py index 6720764..473457d 100644 --- a/examples/plot_parcellation.py +++ b/examples/plot_parcellation.py @@ -14,7 +14,10 @@ subject_id = 'fsaverage' hemi = 'both' surf = 'inflated' -view = 'frontal' +if 'patch' in surf.lower().split('.'): + view=None +else: + view = 'frontal' """ Bring up the visualization diff --git a/examples/plot_probabilistic_label.py b/examples/plot_probabilistic_label.py index 30ba576..da04d59 100644 --- a/examples/plot_probabilistic_label.py +++ b/examples/plot_probabilistic_label.py @@ -52,5 +52,15 @@ prob_field = np.zeros_like(brain.geo['lh'].x) ids, probs = read_label(label_file, read_scalars=True) + +# A slight complication when using a patch: +# When a patch's was loaded (e.g. cortex.patch.flat), brain.geo['lh'] describes +# the patch's vertices, not the original surface's vertices. The following +# command transform the original vertices ('ids') to the patch's vertices. It +# also applies the same filtering to 'probs'. Note that some vertices might be +# present only in the original surface. + +if brain.patch_mode: + ids,probs=brain.geo['lh'].surf_to_patch_vertices(ids,probs) prob_field[ids] = probs brain.add_data(prob_field, thresh=1e-5, colormap="RdPu") diff --git a/examples/plot_resting_correlations.py b/examples/plot_resting_correlations.py index 97b1530..52f0f92 100644 --- a/examples/plot_resting_correlations.py +++ b/examples/plot_resting_correlations.py @@ -15,8 +15,17 @@ print(__doc__) """Bring up the visualization""" -brain = Brain("fsaverage", "split", "inflated", - views=['lat', 'med'], background="white") +surf='cortex.patch.flat' # try 'cortex.patch.flat' + +if not 'patch' in surf.lower().split('.'): + views=['lat', 'med'] + hemi="split" +else: + views=None + hemi="both" + +brain = Brain("fsaverage", hemi, surf, + views=views, background="white") """Project the volume file and return as an array""" mri_file = "example_data/resting_corr.nii.gz" diff --git a/surfer/utils.py b/surfer/utils.py index 8e3e22c..164f333 100644 --- a/surfer/utils.py +++ b/surfer/utils.py @@ -175,6 +175,201 @@ def apply_xfm(self, mtx): self.coords = np.dot(np.c_[self.coords, np.ones(len(self.coords))], mtx.T)[:, :3] +class Patch(Surface): + """Container for patch object + + Attributes + ---------- + subject_id : string + Name of subject + hemi : {'lh', 'rh'} + Which hemisphere to load + surf: string + Name of the patch to load (e.g., for left hemi, will look for lh.patch) + subjects_dir : str | None + If not None, this directory will be used as the subjects directory + instead of the value set using the SUBJECTS_DIR environment variable. + offset : float | None + If float, align inside edge of each hemisphere to center + offset. + If None, do not change coordinates (default). + units : str + Can be 'm' or 'mm' (default). + """ + + def load_geometry(self): + patch_path = op.join(self.data_path, "surf", + "%s.%s" % (self.hemi, self.surf)) + patch = read_patch_file(patch_path) + coords=np.stack([patch['x'],patch['y'],patch['z']],axis=1) + if self.units == 'm': + coords /= 1000. + if self.offset is not None: + if self.hemi == 'lh': + coords[:, 1] -= (np.max(coords[:, 1]) + self.offset) + else: + coords[:, 1] -= (np.min(coords[:, 1]) + self.offset) + coords[:, 0] -= np.mean(coords[:, 0]) # this aligns the vertical center of mass between the two hemis + + # The patch file specifies selected vertices' indecis and coordinates + # but it doesn't include the mesh faces. + # Therefore, we load a surface geometry to extract these. + + surface_to_take_faces_from='orig' + surf_path = op.join(self.data_path, "surf", + "%s.%s" % (self.hemi, surface_to_take_faces_from)) + orig_coords, orig_faces = nib.freesurfer.read_geometry(surf_path) + n_orig_vertices=orig_coords.shape[0] + assert np.max(patch['vno']) < n_orig_vertices, 'mismatching vertices in patch and orig surface' + + # re-define faces to use the indecis of the selected vertices + patch_vertices_in_original_surf_indexing=patch['vno'] + + # reverse the lookup table: + original_vertices_in_patch_indexing=np.zeros((n_orig_vertices,)); original_vertices_in_patch_indexing[:]=np.nan + original_vertices_in_patch_indexing[patch_vertices_in_original_surf_indexing]=np.arange(len(patch_vertices_in_original_surf_indexing)) + + # apply the reversed lookup table on the uncut faces: + orig_faces_in_patch_indexing=original_vertices_in_patch_indexing[orig_faces] + + n_selected_vertices=np.sum(~np.isnan(orig_faces_in_patch_indexing),axis=1) + valid_faces=n_selected_vertices==3 + faces=np.asarray(orig_faces_in_patch_indexing[valid_faces],dtype=np.int) # these are the patch faces with patch vertex indexing + + # sanity check - every patch vertex has to be a member in at least one patch face + assert np.min(np.bincount(faces.flatten()))>=1 + + nn = _compute_normals(coords, faces) + +# # for a flat patch, all vertex normals should point at the same direction + if 'flat' in self.surf: + from scipy import stats + common_normal=stats.mode(nn,axis=0)[0] + nn=np.tile(common_normal,[nn.shape[0],1]) + + if self.coords is None: + self.coords = coords + self.faces = faces + self.nn = nn + else: + self.coords[:] = coords + self.faces[:] = faces + self.nn[:] = nn + + # in order to project overlays, labels and so on, + # we need to save an index-array that transforms + # the data from its original surface-indexing to the patch indexing + self.patch_vertices_in_original_surf_indexing=patch_vertices_in_original_surf_indexing + self.original_vertices_in_patch_indexing=original_vertices_in_patch_indexing + self.n_original_surface_vertices=len(self.original_vertices_in_patch_indexing) + self.n_patch_vertices=len(self.patch_vertices_in_original_surf_indexing) + + def load_curvature(self): + """ load curtvature for patch """ + super().load_curvature() # start with loading the normal curvature + + self.curv =self.surf_to_patch_array(self.curv) + self.bin_curv =self.surf_to_patch_array(self.bin_curv) + + def load_label(self, name): + """Load in a Freesurfer .label file. + + Label files are just text files indicating the vertices included + in the label. Each Surface instance has a dictionary of labels, keyed + by the name (which is taken from the file name if not given as an + argument. + + """ + label = nib.freesurfer.read_label(op.join(self.data_path, 'label', + '%s.%s.label' % (self.hemi, name))) + label=self.surf_to_patch_vertices(label) + label_array = np.zeros(len(self.x), np.int) + label_array[label] = 1 + try: + self.labels[name] = label_array + except AttributeError: + self.labels = {name: label_array} + + def surf_to_patch_array(self,array): + """ cut a surface array into a patch array + + When an input (data, label and so on) is fed to a patch object, + it has to be transformed from the original surface vertex indexing + to the vertex indexing of the patch. + + returns a cut array, indexed according to the patch's vertices. + """ + if array.shape[0] == self.n_original_surface_vertices: + # array is given in original (uncut) surface indexing + array=array[self.patch_vertices_in_original_surf_indexing] + elif array.shape[0]==self.n_patch_vertices: + # array is given in cut surface indexing. do nothing + pass + else: + raise Exception('array height ({}) is inconsistent with either patch ({}) or uncut surface ({})'.format( + array.shape[0],self.n_patch_vertices,self.n_original_surface_vertices)) + return array + def surf_to_patch_vertices(self,vertices,*args): + """ cut a surface vertex set into a patch vertex set + + Given a vector of surface indecis, returns a vector of patch vertex + indecis. Note that the returned vector might be shorter than the + original if some of the vertices are not included in the patch. + If additional arguments are provided, they are assumed to be vectors or + arrays whose first dimension is corresponding to the vertices provided. + They are returned with the missing vertices removed. + + return transformed vertices, and potentially the cut optional data vectors/arrays. + """ + + # if vertices are supplied, filter them according them to the patch's vertices + if not isinstance(vertices,np.ndarray): # vertices might be a list + vertices=np.asarray(vertices) + original_dtype=vertices.dtype + + vertices=self.original_vertices_in_patch_indexing[vertices] + # find NaN indecis (-> vertices outside of the patch) + vertices_in_patch=np.logical_not(np.isnan(vertices)) + + # remove the missing vertices + vertices=vertices[vertices_in_patch] + vertices=np.array(vertices,original_dtype) + if len(args)==0: + return vertices + else: + cut_v=[] + for v in args: + cut_v.append(np.asarray(v)[vertices_in_patch]) + return (vertices,)+tuple(cut_v) +def read_patch_file(fname): + """ loads a FreeSurfer binary patch file + # This is a Python adaptation of Bruce Fischl's read_patch.m (FreeSurfer Matlab interface) + """ + def read_an_int(fid): + return np.asscalar(np.fromfile(fid,dtype='>i4',count=1)) + + patch={} + with open(fname,'r') as fid: + ver=read_an_int(fid) # '> signifies big endian' + if ver != -1: + raise Exception('incorrect version # %d (not -1) found in file'.format(ver)) + + patch['npts'] = read_an_int(fid) + + rectype = np.dtype( [ ('ind', '>i4'), ('x', '>f'), ('y', '>f'), ('z','>f') ]) + recs = np.fromfile(fid,dtype=rectype,count=patch['npts']) + + recs['ind']=np.abs(recs['ind'])-1 # strange correction to indexing, following the Matlab source... + patch['vno']=recs['ind'] + patch['x']=recs['x'] + patch['y']=recs['y'] + patch['z']=recs['z'] + + # make sure it's sorted + index_array=np.argsort(patch['vno']) + for field in ['vno','x','y','z']: + patch[field]=patch[field][index_array] + return patch + def _fast_cross_3d(x, y): """Compute cross product between list of 3D vectors diff --git a/surfer/viz.py b/surfer/viz.py index 14b921c..274ca10 100644 --- a/surfer/viz.py +++ b/surfer/viz.py @@ -23,7 +23,7 @@ from traitsui.api import View, Item, Group, VGroup, HGroup, VSplit, HSplit from . import utils, io -from .utils import (Surface, verbose, create_color_lut, _get_subjects_dir, +from .utils import (Surface, Patch, verbose, create_color_lut, _get_subjects_dir, string_types, threshold_filter, _check_units) @@ -37,7 +37,8 @@ 'dorsal': {'v': (180., 0.), 'r': 90.}, 'ventral': {'v': (180., 180.), 'r': 90.}, 'frontal': {'v': (120., 80.), 'r': 106.739}, - 'parietal': {'v': (-120., 60.), 'r': 49.106}} + 'parietal': {'v': (-120., 60.), 'r': 49.106}, + 'flatmap': {'v': (0., 0.), 'r': -90}} rh_viewdict = {'lateral': {'v': (180., -90.), 'r': -90.}, 'medial': {'v': (0., -90.), 'r': 90.}, 'rostral': {'v': (-90., -90.), 'r': 180.}, @@ -45,7 +46,8 @@ 'dorsal': {'v': (180., 0.), 'r': 90.}, 'ventral': {'v': (180., 180.), 'r': 90.}, 'frontal': {'v': (60., 80.), 'r': -106.739}, - 'parietal': {'v': (-60., 60.), 'r': -49.106}} + 'parietal': {'v': (-60., 60.), 'r': -49.106}, + 'flatmap': {'v': (0., 0.), 'r': -90}} viewdicts = dict(lh=lh_viewdict, rh=rh_viewdict) @@ -361,7 +363,9 @@ class Brain(object): views to use offset : bool If True, aligs origin with medial wall. Useful for viewing inflated - surface where hemispheres typically overlap (Default: True) + surface where hemispheres typically overlap. For flat patches, + this aligns the two patches along their posterior + edges. (Default: True) show_toolbar : bool If True, toolbars will be shown for each view. offscreen : bool | str @@ -391,18 +395,25 @@ class Brain(object): The overlays. texts : dict The text objects. + patch_mode: logical + True if a patch is visualized instead of a standard surface. """ def __init__(self, subject_id, hemi, surf, title=None, cortex="classic", alpha=1.0, size=800, background="black", foreground=None, figure=None, subjects_dir=None, - views=['lat'], offset=True, show_toolbar=False, + views=None, offset=True, show_toolbar=False, offscreen='auto', interaction='trackball', units='mm'): if not isinstance(interaction, string_types) or \ interaction not in ('trackball', 'terrain'): raise ValueError('interaction must be "trackball" or "terrain", ' 'got "%s"' % (interaction,)) + + self.patch_mode = 'patch' in surf.lower().split('.') + if views is None: + views={False:['lat'],True:['flatmap']}[self.patch_mode] + self._units = _check_units(units) col_dict = dict(lh=1, rh=1, both=1, split=2) n_col = col_dict[hemi] @@ -435,8 +446,12 @@ def __init__(self, subject_id, hemi, surf, title=None, geo_kwargs, geo_reverse, geo_curv = self._get_geo_params(cortex, alpha) for h in geo_hemis: # Initialize a Surface object as the geometry - geo = Surface(subject_id, h, surf, subjects_dir, offset, - units=self._units) + if self.patch_mode: + geo = Patch(subject_id, h, surf, subjects_dir, offset, + units=self._units) + else: + geo = Surface(subject_id, h, surf, subjects_dir, offset, + units=self._units) # Load in the geometry and (maybe) curvature geo.load_geometry() if geo_curv: @@ -936,6 +951,10 @@ def add_overlay(self, source, min=2, max="robust_max", sign="abs", hemi = self._check_hemi(hemi) # load data here scalar_data, name = self._read_scalar_data(source, hemi, name=name) + + if self.patch_mode: + scalar_data = self.geo[hemi].surf_to_patch_array(scalar_data) + min, max = self._get_display_range(scalar_data, min, max, sign) if sign not in ["abs", "pos", "neg"]: raise ValueError("Overlay sign must be 'abs', 'pos', or 'neg'") @@ -1051,6 +1070,11 @@ def add_data(self, array, min=None, max=None, thresh=None, hemi = self._check_hemi(hemi) array = np.asarray(array) + if self.patch_mode: + if vertices is None: + array = self.geo[hemi].surf_to_patch_array(array) + else: + vertices, array = self.geo[hemi].surf_to_patch_vertices(vertices,array) if center is None: if min is None: min = array.min() if array.size > 0 else 0 @@ -1269,7 +1293,8 @@ def add_annotation(self, annot, borders=True, alpha=1, hemi=None, self.annot_list = [] for hemi, (labels, cmap) in zip(hemis, annots): - + if self.patch_mode: + labels = self.geo[hemi].surf_to_patch_array(labels) # Maybe zero-out the non-border vertices self._to_borders(labels, hemi, borders) @@ -1392,6 +1417,9 @@ def add_label(self, label, color=None, alpha=1, scalar_thresh=None, if scalar_thresh is not None: ids = ids[scalars >= scalar_thresh] + if self.patch_mode: + ids = self.geo[hemi].surf_to_patch_vertices(ids) + label = np.zeros(self.geo[hemi].coords.shape[0]) label[ids] = 1 @@ -1581,6 +1609,8 @@ def add_morphometry(self, measure, grayscale=False, hemi=None, # Read in the morphometric data morph_data = nib.freesurfer.read_morph_data(morph_file) + if self.patch_mode: + morph_data = self.geo[hemi].surf_to_patch_array(morph_data) # Get a cortex mask for robust range self.geo[hemi].load_label("cortex") @@ -1646,6 +1676,12 @@ def add_foci(self, coords, coords_as_verts=False, map_surface=None, # Figure out how to interpret the first parameter if coords_as_verts: + if self.patch_mode: + patch_coords=self.geo[hemi].surf_to_patch_vertices(coords) + if len(patch_coords)