Exemple #1
0
void compute_LapMatrix_4m_AMatrix(Sinogram* SinogramPtr, Real_t*** LapMatrix2D, Real_t** AMatrix2DLine, int32_t* r_ax_start, int32_t* r_ax_count, int32_t* t_ax_start, int32_t* t_ax_count)
{
    int32_t i, j, m, n, row, col;

    if (*r_ax_count != 0 && *t_ax_count != 0)
    {
        (*LapMatrix2D) = (Real_t**)multialloc(sizeof(Real_t), 2, *r_ax_count+2, *t_ax_count+2);
        memset(&((*LapMatrix2D)[0][0]), 0, (*r_ax_count+2)*(*t_ax_count+2)*sizeof(Real_t));
        for (i = 0; i < *r_ax_count+2; i++)
            for (j = 0; j < *t_ax_count+2; j++)
                for (m = -1; m <= 1; m++)
                    for (n = -1; n <= 1; n++)
                    {
                        row = i + m - 1;
                        col = j + n - 1;
                        if (row >= 0 && col >= 0 && row < *r_ax_count && col < *t_ax_count)
                            (*LapMatrix2D)[i][j] += SinogramPtr->Lap_Kernel[m+1][n+1]*(*AMatrix2DLine)[row];
                    }
        *r_ax_count = *r_ax_count + 2;
        *t_ax_count = *t_ax_count + 2;
        *r_ax_start = *r_ax_start - 1;
        *t_ax_start = *t_ax_start - 1;

        if (*r_ax_start < 0)
        {
            for (i = 0; i < *r_ax_count - 1; i++)
                for (j = 0; j < *t_ax_count; j++)
                    (*LapMatrix2D)[i][j] = (*LapMatrix2D)[i+1][j];
            *r_ax_start = 0;
            *r_ax_count -= 1;
        }

        if (*t_ax_start < 0)
        {
            for (i = 0; i < *r_ax_count; i++)
                for (j = 0; j < *t_ax_count - 1; j++)
                    (*LapMatrix2D)[i][j] = (*LapMatrix2D)[i][j+1];
            *t_ax_start = 0;
            *t_ax_count -= 1;
        }

        if (*r_ax_start + *r_ax_count > SinogramPtr->N_r)
        {
            *r_ax_count -= 1;
        }

        if (*t_ax_start + *t_ax_count > SinogramPtr->N_t)
        {
            *t_ax_count -= 1;
        }

        multifree(*AMatrix2DLine,1);
    }
}
Exemple #2
0
static void seq_MAP_routine(unsigned char ***sf_pym,	/* pyramid of segmentations */
			    struct Region *region,	/* specifies image subregion */
			    LIKELIHOOD **** ll_pym,	/* pyramid of class statistics */
			    int M,	/* number of classes */
			    double *alpha_dec	/* decimation parameters returned by seq_MAP */
    )
{
    int j, k;			/* loop index */
    int wd, ht;			/* width and height at each resolution */
    int *period;		/* sampling period at each resolution */
    int D;			/* number of resolutions -1 */
    double ***N;		/* transition probability statistics; N[2][3][2] */
    double alpha[3];		/* transition probability parameters */
    double tmp[3];		/* temporary transition probability parameters */
    double diff1;		/* change in parameter estimates */
    double diff2;		/* change in log likelihood */
    struct Region *regionary;	/* array of region stuctures */

    /* determine number of resolutions */
    D = levels_reg(region);

    /* allocate memory */
    if ((N = (double ***)multialloc(sizeof(double), 3, 2, 3, 2)) == NULL)
	G_fatal_error(_("Unable to allocate memory"));

    regionary = (struct Region *)G_malloc((D + 1) * sizeof(struct Region));
    period = (int *)G_malloc(D * sizeof(int));

    /* Compute the image region at each resolution.       */
    k = 0;
    copy_reg(region, &(regionary[k]));
    reg_to_wdht(&(regionary[k]), &wd, &ht);
    while ((wd > 2) && (ht > 2)) {
	copy_reg(&(regionary[k]), &(regionary[k + 1]));
	dec_reg(&(regionary[k + 1]));
	reg_to_wdht(&(regionary[k + 1]), &wd, &ht);
	k++;
    }

    /* Compute sampling period for EM algorithm at each resolution. */
    for (k = 0; k < D; k++) {
	period[k] = (int)pow(2.0, (D - k - 2) / 2.0);
	if (period[k] < 1)
	    period[k] = 1;
    }

    /* Compute Maximum Likelihood estimate at coarsest resolution */
    MLE(sf_pym[D], ll_pym[D], &(regionary[D]), M);

    /* Initialize the transition parameters */
    alpha[0] = 0.5 * (3.0 / 7.0);
    alpha[1] = 0.5 * (2.0 / 7.0);
    alpha[2] = 0.0;

    /* Interpolate the classification at each resolution */
    for (D--; D >= 0; D--) {
	G_debug(1, "Resolution = %d; period = %d", D, period[D]);

	for (j = 0; j < 3; j++)
	    alpha[j] *= (1 - EM_PRECISION * 10);
	print_alpha(alpha);
	/* Apply EM algorithm to estimate alpha. Continue for *
	 * fixed number of iterations or until convergence.   */
	do {
	    interp(sf_pym[D], &(regionary[D]), sf_pym[D + 1], ll_pym[D], M,
		   alpha, period[D], N, 1);
	    print_N(N);
	    G_debug(4, "log likelihood = %f", log_like(N, alpha, M));
	    for (j = 0; j < 3; j++)
		tmp[j] = alpha[j];

	    alpha_max(N, alpha, M, ML_PRECISION);
	    print_alpha(alpha);
	    G_debug(4, "log likelihood = %f", log_like(N, alpha, M));

	    for (diff1 = j = 0; j < 3; j++)
		diff1 += fabs(tmp[j] - alpha[j]);
	    diff2 = log_like(N, alpha, M) - log_like(N, tmp, M);
	} while ((diff1 > EM_PRECISION) && (diff2 > 0));
	interp(sf_pym[D], &(regionary[D]), sf_pym[D + 1], ll_pym[D], M, alpha,
	       1, N, 0);
	alpha_dec[D] = alpha_dec_max(N);

	print_N(N);
	alpha_max(N, alpha, M, ML_PRECISION);
	print_alpha(alpha);
    }

    /* free up N */
    G_free((char *)regionary);
    G_free((char *)period);
    multifree((char *)N, 3);
}
Exemple #3
0
void remove_lines_2(image_t* img,params* parameters,uint32_t numCuts,image_t* lineless_img, uint32_t* stafflines, staff_info* staff){
/*initlize stafflines to a 5 elt array*/	
	uint32_t line_thickness, line_spacing, line_w, beginCut, endCut, *yprojection, linesFound, *stafflines_tmp,
		**STAFFLINES, i, j, vertSplice, sum, max_project, loc, eraseTop,
		 eraseBottom, min_thisLineY,max_thisLineY, shift_variable,h,w, **last_stafflines, ii, jj;
	int32_t min_thisLineY_tmp;
	image_t *fixThatImage;
	
	h = img->height;
	w = img->width;
/*CHANGES: GET RID OF*/
/*	line_thickness = (uint32_t)(parameters->thickness);
	line_spacing = (uint32_t)(parameters->spacing);*/
/*END CHANGES*/
	line_w = (uint32_t)(parameters->thickness + parameters->spacing);
	beginCut = 0;
/*CHANGES: W-1 => W*/
	endCut = (uint32_t)((w)/numCuts);
/*END CHANGES*/
	yprojection= (uint32_t *)mget_spc((uint32_t)h, sizeof(uint32_t));
	for(i=0;i<h;i++){
		sum = 0;
		for(j=0;j<w;j++){
			sum += getPixel(img,i,j);
		}
		yprojection[i] = sum;
	}
	linesFound = 0;	
	stafflines_tmp = (uint32_t *)mget_spc((uint32_t)10, sizeof(uint32_t));
	while(linesFound < 5){
		max_project = yprojection[0];
		loc = 0;
		for(i=1; i<h; i++){
			if(yprojection[i]>max_project){
				max_project = yprojection[i];
				loc = i;
			}
		}
    		linesFound = linesFound + 1;
    
    		/*all y coordinates of a line that is part of same staff line:*/
    		eraseTop = loc-(uint32_t)((line_w+1)/3 );
    		eraseBottom = loc+(uint32_t)((line_w+1)/3);
    		if (eraseTop < 0){ eraseTop = 0; } /*avoid segfault*/
    		if (eraseBottom > h-1){ eraseBottom = h-1; } /*avoid segfault*/
		
		min_thisLineY_tmp = -1;
		for(i=eraseTop; i<=eraseBottom; i++){
			if(yprojection[i]>=(9*max_project)/10){
				if(min_thisLineY_tmp == -1){				
					min_thisLineY_tmp = i;
				}
				max_thisLineY = i;
			}
			/*erase to avoid line in futher iterations*/
			yprojection[i] = 0;		
		}
		min_thisLineY = (uint32_t)(min_thisLineY_tmp);

		stafflines_tmp[2*(linesFound-1)] = min_thisLineY;
		stafflines_tmp[2*(linesFound-1)+1] = max_thisLineY;
	}
	free(yprojection);
	quickSort(stafflines_tmp,0,9);
	last_stafflines = (uint32_t **)multialloc (sizeof(uint32_t),2, 5,2);
	STAFFLINES = (uint32_t **)multialloc (sizeof (uint32_t),2, 5,2);
	
	for(i=0; i<5; i++){
		last_stafflines[i][0] = stafflines_tmp[2*i];
		last_stafflines[i][1] = stafflines_tmp[2*i + 1];
	}
	free(stafflines_tmp);
	/*LOOP THRU VERTICAL CUTS*/
	shift_variable=0;
	for(vertSplice =0; vertSplice<numCuts; vertSplice++){
		fixThatImage = get_sub_img(img,-1,-1,beginCut,endCut);
    		/*pretty up staff lines*/
		fix_lines_and_remove(fixThatImage,parameters,last_stafflines,&shift_variable, vertSplice);
		for(ii=0;ii<h;ii++){
			for(jj=beginCut;jj<=endCut;jj++){
				setPixel(img,ii,jj,getPixel(fixThatImage,ii,jj-beginCut));
			}
		}
		delete_image(fixThatImage);

    		if (vertSplice==0){
			for(i=0; i<5; i++){
                     
				STAFFLINES[i][0] = last_stafflines[i][0];
				STAFFLINES[i][1] = last_stafflines[i][1];
			}
    		}


    		beginCut = endCut + 1;
/*CHANGED: W-1 TO W*/
    		endCut = endCut + (uint32_t)((w)/numCuts) + 1;
/*END CHANGED*/
    		if (endCut > w-1){
        		endCut = w-1;
    		}
	}

	/*copy over image*/
	for(i=0; i<h;i++){
		for(j=0; j<w;j++){
			setPixel(lineless_img,i,j,getPixel(img,i,j));
		}
	}


	for(i=0;i<5;i++){
/*CHANGED 1->0 2->1*/
		stafflines[i] = (uint32_t)(((STAFFLINES[i][0]+STAFFLINES[i][1]+1)/2)); /*shift because of zero padding above*/
/*END CHANGE*/
	}

	multifree(STAFFLINES,2);
	multifree(last_stafflines,2);
}
Exemple #4
0
void fix_lines_and_remove(image_t* img,params* parameters, uint32_t** last_STAFFLINES, uint32_t *previous_start, uint32_t cutNum){
/*function [result,new_start,STAFFLINES] = fix_lines_and_remove(img,params,last_STAFFLINES,previous_start,cutNum)*/
/*remvoe lines from small portion of staff. also straightens staff.*/
	flex_array_t *stafflines_tmp;	
	uint32_t *yprojection, line_thickness, line_spacing, line_w, *last_STAFFLINES_avg, max_project, sum, h, w,
		i, j, ii, count, **STAFFLINES, dummy, loc, shift, findLine, match, lineBegin,
		lineEnd, found_thickness, middle, tooThick, tooHigh, any_stafflines_zero, now_avg, last_avg, goodLine,
		tooLow, curr, extend, lastDelete, cW, cH, topStop, botStop, thickness, paramThickness, thickness_th,
		topLine, shift_loop,k;
	int16_t *tempData,*temp_array;
	int32_t lineY;
	uint8_t pixelData;
	linked_list *staffLines, *allLINES, *temp;
		
	STAFFLINES=multialloc(sizeof(uint32_t),2,5,2);

	h = img->height;
	w = img->width;
	line_thickness = (uint32_t)(parameters->thickness);
	line_spacing = (uint32_t)(parameters->spacing);
	line_w = (uint32_t)(parameters->thickness + parameters->spacing);
	
	last_STAFFLINES_avg = (uint32_t *)malloc(sizeof(uint32_t)*5);/*mget_spc((uint32_t)5, sizeof(uint32_t));*/
	for(i=0; i<5; i++){
		last_STAFFLINES_avg[i] = (uint32_t)((last_STAFFLINES[i][0] + last_STAFFLINES[i][1] + 1)/2);
	}
	yprojection= (uint32_t *)mget_spc((uint32_t)h, sizeof(uint32_t));
	max_project = 0;
	for(i=0;i<h;i++){
		sum = 0;
		for(j=0;j<w;j++){
			sum += getPixel(img,i,j);
		}
		yprojection[i] = sum;
		if(yprojection[i] > max_project){
			max_project = yprojection[i];		
		}
	}
	count = 0;
	for(i=0;i<h;i++){
    		if (yprojection[i] >= (9*max_project)/10){    /*delete staff line, twiddle with the 80% later (90%)*/
       			count++;
    		}
	}
	stafflines_tmp=make_flex_array(count);
	count = 0;
	for(i=0;i<h;i++){
    		if (yprojection[i] >= (9*max_project)/10){    /*delete staff line, twiddle with the 80% later (90%)*/
			stafflines_tmp->data[count] = i;       			
			count++;
    		}
	}
	free(yprojection);
	staffLines = group(stafflines_tmp, 3);
/*CHANGE: CUTNUM = 1 TO 0*/
	if (cutNum == 0 && staffLines->length == 5 ){
/*END CHANGE*/
		i=0;
	    	while(is_list_empty(staffLines)==0){
			tempData=(int16_t*)pop_top(staffLines);
			STAFFLINES[i][0] = tempData[0];
			STAFFLINES[i][1] = tempData[1];
			i++;
			free(tempData);
		}
	}
	else if ((staffLines->length) == 0){		
		for(i=0;i<5;i++){
			STAFFLINES[i][0] = last_STAFFLINES[i][0];
			STAFFLINES[i][1] = last_STAFFLINES[i][1];
		}
	}
/*CHANGE: CUTNUM = 1 TO 0*/
	else if (cutNum == 0 && (staffLines->length) < 5){
/*END CHANGE*/
	    	/*choose one line, then find closest line in last_STAFFLINES*/
		tempData = (int16_t*)(getIndexData(staffLines, 0));
	    	goodLine = (uint32_t)((tempData[0]+tempData[1]+1)/2);
		
		dummy = abs(last_STAFFLINES_avg[0] - goodLine);
		loc = 0;		
		for(i=1;i<5;i++){
			curr = abs(last_STAFFLINES_avg[i] - goodLine);
			if(curr<dummy){
				dummy = curr;				
				loc = i;
			}
		}
	    	shift = goodLine - last_STAFFLINES_avg[loc];
	    
	    	for(i=0;i<5;i++){
			STAFFLINES[i][0] = last_STAFFLINES[i][0]+shift;
			STAFFLINES[i][1] = last_STAFFLINES[i][1]+shift;
		}
	}
	

	else{
		count = 0;
		for(findLine=0;findLine<5;findLine++){

			match = 0;
			for(i=0;i<(staffLines->length);i++){
				tempData = (int16_t*)(getIndexData(staffLines, i));
			    	lineBegin = (uint32_t)tempData[0];
			    	lineEnd = (uint32_t)tempData[1];
				/*lineBegin is top of line, lineEnd is bottom*/

			    	found_thickness = lineEnd-lineBegin+1;
/*CHANGED: 0.5 TO 1/2*/
			    	middle = (uint32_t)((lineBegin + lineEnd+1)/2);
/*END CHANGED*/

			    	/*determine if the line is of expected location/size*/
				tooThick = 0;
				tooHigh = 0;
				tooLow = 0;
			    	if(found_thickness > (line_thickness+2)) tooThick=1;
				if(middle < (last_STAFFLINES_avg[findLine] - 3)) tooHigh=1;
				if(middle > (last_STAFFLINES_avg[findLine] + 3)) tooLow=1;
/*CHANGED: 1 TO 0*/
			    	if (cutNum == 0){
/*END CHANGED*/
					tooHigh = 0;
					tooLow = 0;
					if(middle < (last_STAFFLINES_avg[0] - 2*line_spacing)){tooHigh=1;}
/*CHANGED + TO - ALSO, avg[5] -> avg[4] */
					if(middle > (last_STAFFLINES_avg[4] + 2*line_spacing)){tooLow=1;}
/*END CHANGED*/
			    	}

			    	if (tooThick || tooHigh || tooLow){
					continue;
			    	}
			    	else{ /*we found good match for staffline*/
					match = 1;
					/*SAVE STAFF LINE LOCATIONS*/
					STAFFLINES[count][0] = lineBegin;
					STAFFLINES[count][1] = lineEnd;
					count++;
					deleteIndexData(staffLines,i);
					break;
			    	}        



			} /*end looping thru found lines*/

			if(!match){ /*CHANGED*/
		    		/*flag that no match was found*/
		    		STAFFLINES[count][0] = 0;
				STAFFLINES[count][1] = 0;
				count++;
			} 

	    	} /*end looping through matching staff lines*/
	    
	    	/*CHANGED BELOW*/
	    
	    	/*check for lines that did not get match*/
		any_stafflines_zero = 0;
		for(i=0;i<5;i++){
			if(STAFFLINES[i][0] == 0){
				any_stafflines_zero = 1;
				break;
			}
		}
	    	if (any_stafflines_zero){
			/*find shift value first*/
			shift = 100; /*big value*/
			for (findLine = 0; findLine<5;findLine++){
			/*loop to find nonzero entry in STAFFLINES, then calculate shift*/
			    if (STAFFLINES[findLine][0]){ /*if nonzero*/
				now_avg = (uint32_t)((STAFFLINES[findLine][0]+STAFFLINES[findLine][1]+1)/2);
				last_avg = last_STAFFLINES_avg[findLine];
				shift = now_avg - last_avg;
				break;
			    }
			}
			if (shift==100){ shift = 0;}
			/*replace any flagged (with 0) entries in STAFFLINES*/
			for(findLine=0;findLine<5;findLine++){
			    	if (STAFFLINES[findLine][0] == 0){
					STAFFLINES[findLine][0] = last_STAFFLINES[findLine][0]+shift;
					STAFFLINES[findLine][1] = last_STAFFLINES[findLine][1]+shift;
			    	}
			}
		}
	}

	extend = (uint32_t)((line_w+2)/4)+1;
	/*create stafflines above*/
	allLINES=create_linked_list();
	lineY = (int32_t)(((STAFFLINES[0][0] + STAFFLINES[0][1]+1)/2) - line_w); /*first above line*/
	while (1){
   		if (lineY < (int32_t)(extend + 2)){
       			break;
		}   		
		else{
			temp_array=malloc(sizeof(int16_t)*2);
			temp_array[0]=(int16_t)lineY;
			temp_array[1]=(int16_t)lineY;
			push_top(allLINES,temp_array);
       			lineY = (int32_t)(lineY - (int32_t)line_w );
   		}
	}
	for(i=0;i<5;i++){
		temp_array=malloc(sizeof(uint32_t)*2);
		temp_array[0]=(int16_t)STAFFLINES[i][0];
		temp_array[1]=(int16_t)STAFFLINES[i][1];
		push_bottom(allLINES,temp_array);
	}
	/*create stafflines below*/
	lineY = (uint32_t)(((STAFFLINES[4][0] + STAFFLINES[4][1]+1)/2) + line_w); /*first above line*/
	while (1){
   		if (lineY > (h - extend - 3)){
       			break;
		}   		
		else{
			temp_array=malloc(sizeof(int16_t)*2);
			temp_array[0]=(int16_t)lineY;
			temp_array[1]=(int16_t)lineY;
			push_bottom(allLINES,temp_array);
			lineY = (uint32_t)(lineY + (int32_t)line_w);
   		}
	}
	/*REMOVE STAFF LINES*/

	while( is_list_empty(allLINES)==0){
		tempData = (int16_t*)pop_top(allLINES);
		lineBegin = tempData[0];
		lineEnd = tempData[1];
		middle = (lineBegin + lineEnd + 1)/2;
		lastDelete = 0;
		free(tempData);
    
    
    		for(j=0;j<w;j++){
        
        		/*top of staff line*/
        		topStop = 0;
/*CHANGED*/
        		for(ii = (lineBegin-1); ii>=(lineBegin-extend); ii--){
/*END CHANGED*/
            			if (ii < 0){
                			break;
            			}
            			if (getPixel(img,ii,j)==0){ /*then erase*/
                			topStop = ii+1;
                			break;
            			}
        		}
    
			/*bottom of staff line*/
			botStop = h-1;
/*CHANGED*/
			for(ii = lineEnd+1; ii<=(lineEnd+extend); ii++){
/*END CHANGED*/
	     	      	 	if (ii > h-1){
	      	          		break;
		    		}
		    		if(getPixel(img,ii,j)==0){
		        		botStop = ii-1;              
		        		break;
		    		}
			}
	    
		
			/*check thickness of line, delete if skinny*/
	       	 	thickness = botStop - topStop + 1;
	       	 	if (parameters->thickness < 3){
		    		paramThickness = parameters->thickness + 1;
			}
			else{
		    		paramThickness = parameters->thickness;
			}
			if (lastDelete){ /*there was a line deletion last iteration*/
		    		thickness_th = paramThickness*2; /*higher threshold*/
			}
			else{
		    		thickness_th = paramThickness*2-2;
			}
			if (thickness <= thickness_th){
				for(ii=topStop; ii<=botStop; ii++){ 
		    			setPixel(img,ii,j,0);
				}
		    		lastDelete = 1;
			}
			else{
		    		lastDelete = 0;
			}
    
    		}
        
	} /*end staff line*/
	topLine = STAFFLINES[0][0];
	if(*previous_start){
    		if(*previous_start<topLine){
        		shift=topLine-(*previous_start);
/*CHANGED H-SHIFT-1 TO H-SHIFT*/
			for(shift_loop=0; shift_loop<(h-shift); shift_loop++){
/*END CHANGED*/
				for(cW=0; cW<w; cW++){
					pixelData=getPixel(img,shift_loop+shift,cW);
		    			setPixel(img,shift_loop,cW,pixelData);
				}
			}
			for(cH=h-shift-1; cH<h; cH++){
				for(cW=0; cW<w; cW++){
		    			setPixel(img,cH,cW,0);
				}
			}      	
		}
    		else if(*previous_start>topLine){
        		shift=*previous_start-topLine;
		
			for(shift_loop=h-1; shift_loop>=shift; shift_loop--){
				for(cW=0; cW<w; cW++){
					pixelData=getPixel(img,shift_loop-shift,cW);
		    			setPixel(img,shift_loop,cW, pixelData);
				}
			}
/*CHANGED: SHIFT-1 TO SHIFT*/
			for(cH=0; cH<shift; cH++){
/*END CHANGED*/
				for(cW=0; cW<w; cW++){
		    			setPixel(img,cH,cW,0);
				}
			}
		}	
	}
	else{
	    	*previous_start=topLine;
	}

	for(i=0; i<5;i++){
		last_STAFFLINES[i][0] = STAFFLINES[i][0];
		last_STAFFLINES[i][1] = STAFFLINES[i][1];
	}
	delete_list(staffLines);
	delete_list(allLINES);
	multifree(STAFFLINES,2);
}
Exemple #5
0
linked_list* connComponents(const image_t *imgGy,int32_t minNumPixels){

	int32_t i,j;
	struct pixel seed;
	uint8_t T;
	uint8_t **dummy;
	int32_t Nset, ClassLabel;
	int32_t dummyClass;
	symbol_t *symbol, *symbol_tmp;
	linked_list *symbols_list;
	int32_t height, width;

	height = imgGy->height;
	width = imgGy->width;

	/* Set up segmented image structure */
	dummy=(uint8_t **) multialloc (sizeof (uint8_t), 2, (int)height, (int)width);
	symbols_list = create_linked_list();
	symbol_tmp = malloc(sizeof(symbol_t));

	/********************** Segment Image ******************/

	/* set threshold  */
	T=1;

	/* Initialize segmentation image */
	for ( i = 0; i < height; i++ ){
		for ( j = 0; j < width; j++ )
		{
			dummy[i][j] = 0;
		}
	}

	dummyClass = -1;

	/* Start class labeling at 1 */
	ClassLabel = 1;

	for ( i = 0; i < height; i++ )
		for ( j = 0; j < width; j++ )
		{
			/* If not yet classified */
			if (dummy[i][j] == 0 && getPixel(imgGy,i,j) == 1)
			{
				seed.row=i;
				seed.col=j;
				/* using this only to find Nset; will also indicate tested regions */
				ConnectedSet(seed, T, imgGy, width, height,
				             &dummyClass, dummy, &Nset, symbol_tmp);
				/* If more than 100 pixels, classify set*/
				if (Nset > minNumPixels)
				{
					symbol = malloc(sizeof(symbol_t));
					symbol->top=(uint16_t)height; symbol->bottom=0; 
					symbol->left=(uint16_t)width; symbol->right=0;

					ConnectedSet(seed, T, imgGy, width,
					             height, &ClassLabel, dummy, &Nset, symbol);

					symbol->height = (uint16_t)(symbol->bottom - symbol->top + 1);
					symbol->width = (uint16_t)(symbol->right - symbol->left + 1);
					symbol->HtW = (uint16_t)(symbol->height/symbol->width);
					symbol->NumBlack = (uint16_t)(Nset);
		
					symbol->class_label = -1;

					push_bottom(symbols_list, symbol);
	
					ClassLabel = ClassLabel + 1;
					if (ClassLabel > 255)
					{
						printf("Error: More than 256 classes.\n");
						printf("Need to increase minimum pixels per class.\n");
						exit(1);
					}
				}
			}
		}

	ClassLabel = ClassLabel - 1;

	
	multifree(dummy, 2);
	free(symbol_tmp);

	return symbols_list;
}