| 123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459 | /* StarPU --- Runtime system for heterogeneous multicore architectures. * * Copyright (C) 2010-2020  Université de Bordeaux, CNRS (LaBRI UMR 5800), Inria * * StarPU is free software; you can redistribute it and/or modify * it under the terms of the GNU Lesser General Public License as published by * the Free Software Foundation; either version 2.1 of the License, or (at * your option) any later version. * * StarPU is distributed in the hope that it will be useful, but * WITHOUT ANY WARRANTY; without even the implied warranty of * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. * * See the GNU Lesser General Public License in COPYING.LGPL for more details. */#include <math.h>#include <assert.h>#include <starpu.h>#include <common/blas.h>#ifdef STARPU_USE_CUDA#include <cuda.h>#endif#define FPRINTF(ofile, fmt, ...) do { if (!getenv("STARPU_SSILENT")) {fprintf(ofile, fmt, ## __VA_ARGS__); }} while(0)/* *	Conjugate Gradient * *	Input: *		- matrix A *		- vector b *		- vector x (starting value) *		- int i_max, error tolerance eps < 1. *	Ouput: *		- vector x * *	Pseudo code: * *		i <- 0 *		r <- b - Ax *		d <- r *		delta_new <- dot(r,r) *		delta_0 <- delta_new * *		while (i < i_max && delta_new > eps^2 delta_0) *		{ *			q <- Ad *			alpha <- delta_new/dot(d, q) *			x <- x + alpha d * *			If (i is divisible by 50) *				r <- b - Ax *			else *				r <- r - alpha q * *			delta_old <- delta_new *			delta_new <- dot(r,r) *			beta <- delta_new/delta_old *			d <- r + beta d *			i <- i + 1 *		} * *	The dot() operations makes use of reduction to optimize parallelism. * */#include "cg.h"static int long long n = 4096;static int nblocks = 8;static int use_reduction = 1;static starpu_data_handle_t A_handle, b_handle, x_handle;static TYPE *A, *b, *x;#ifdef STARPU_QUICK_CHECKstatic int i_max = 5;#elif !defined(STARPU_LONG_CHECK)static int i_max = 100;#elsestatic int i_max = 1000;#endifstatic double eps = (10e-14);static starpu_data_handle_t r_handle, d_handle, q_handle;static TYPE *r, *d, *q;static starpu_data_handle_t dtq_handle, rtr_handle;static TYPE dtq, rtr;extern struct starpu_codelet accumulate_variable_cl;extern struct starpu_codelet accumulate_vector_cl;extern struct starpu_codelet bzero_variable_cl;extern struct starpu_codelet bzero_vector_cl;/* *	Generate Input data */static void generate_random_problem(void){	int i, j;	starpu_malloc((void **)&A, n*n*sizeof(TYPE));	starpu_malloc((void **)&b, n*sizeof(TYPE));	starpu_malloc((void **)&x, n*sizeof(TYPE));	assert(A && b && x);	for (j = 0; j < n; j++)	{		b[j] = (TYPE)1.0;		x[j] = (TYPE)0.0;		/* We take Hilbert matrix that is not well conditionned but definite positive: H(i,j) = 1/(1+i+j) */		for (i = 0; i < n; i++)		{			A[n*j + i] = (TYPE)(1.0/(1.0+i+j));		}	}	/* Internal vectors */	starpu_malloc((void **)&r, n*sizeof(TYPE));	starpu_malloc((void **)&d, n*sizeof(TYPE));	starpu_malloc((void **)&q, n*sizeof(TYPE));	assert(r && d && q);	memset(r, 0, n*sizeof(TYPE));	memset(d, 0, n*sizeof(TYPE));	memset(q, 0, n*sizeof(TYPE));}static void free_data(void){	starpu_free(A);	starpu_free(b);	starpu_free(x);	starpu_free(r);	starpu_free(d);	starpu_free(q);}static void register_data(void){	starpu_matrix_data_register(&A_handle, STARPU_MAIN_RAM, (uintptr_t)A, n, n, n, sizeof(TYPE));	starpu_vector_data_register(&b_handle, STARPU_MAIN_RAM, (uintptr_t)b, n, sizeof(TYPE));	starpu_vector_data_register(&x_handle, STARPU_MAIN_RAM, (uintptr_t)x, n, sizeof(TYPE));	starpu_vector_data_register(&r_handle, STARPU_MAIN_RAM, (uintptr_t)r, n, sizeof(TYPE));	starpu_vector_data_register(&d_handle, STARPU_MAIN_RAM, (uintptr_t)d, n, sizeof(TYPE));	starpu_vector_data_register(&q_handle, STARPU_MAIN_RAM, (uintptr_t)q, n, sizeof(TYPE));	starpu_variable_data_register(&dtq_handle, STARPU_MAIN_RAM, (uintptr_t)&dtq, sizeof(TYPE));	starpu_variable_data_register(&rtr_handle, STARPU_MAIN_RAM, (uintptr_t)&rtr, sizeof(TYPE));	if (use_reduction)	{		starpu_data_set_reduction_methods(q_handle, &accumulate_vector_cl, &bzero_vector_cl);		starpu_data_set_reduction_methods(r_handle, &accumulate_vector_cl, &bzero_vector_cl);		starpu_data_set_reduction_methods(dtq_handle, &accumulate_variable_cl, &bzero_variable_cl);		starpu_data_set_reduction_methods(rtr_handle, &accumulate_variable_cl, &bzero_variable_cl);	}}static void unregister_data(void){	starpu_data_unpartition(A_handle, STARPU_MAIN_RAM);	starpu_data_unpartition(b_handle, STARPU_MAIN_RAM);	starpu_data_unpartition(x_handle, STARPU_MAIN_RAM);	starpu_data_unpartition(r_handle, STARPU_MAIN_RAM);	starpu_data_unpartition(d_handle, STARPU_MAIN_RAM);	starpu_data_unpartition(q_handle, STARPU_MAIN_RAM);	starpu_data_unregister(A_handle);	starpu_data_unregister(b_handle);	starpu_data_unregister(x_handle);	starpu_data_unregister(r_handle);	starpu_data_unregister(d_handle);	starpu_data_unregister(q_handle);	starpu_data_unregister(dtq_handle);	starpu_data_unregister(rtr_handle);}/* *	Data partitioning filters */struct starpu_data_filter vector_filter;struct starpu_data_filter matrix_filter_1;struct starpu_data_filter matrix_filter_2;static void partition_data(void){	assert(n % nblocks == 0);	/*	 *	Partition the A matrix	 */	/* Partition into contiguous parts */	matrix_filter_1.filter_func = starpu_matrix_filter_block;	matrix_filter_1.nchildren = nblocks;	/* Partition into non-contiguous parts */	matrix_filter_2.filter_func = starpu_matrix_filter_vertical_block;	matrix_filter_2.nchildren = nblocks;	/* A is in FORTRAN ordering, starpu_data_get_sub_data(A_handle, 2, i,	 * j) designates the block in column i and row j. */	starpu_data_map_filters(A_handle, 2, &matrix_filter_1, &matrix_filter_2);	/*	 *	Partition the vectors	 */	vector_filter.filter_func = starpu_vector_filter_block;	vector_filter.nchildren = nblocks;	starpu_data_partition(b_handle, &vector_filter);	starpu_data_partition(x_handle, &vector_filter);	starpu_data_partition(r_handle, &vector_filter);	starpu_data_partition(d_handle, &vector_filter);	starpu_data_partition(q_handle, &vector_filter);}/* *	Debug */#if 0static void display_vector(starpu_data_handle_t handle, TYPE *ptr){	unsigned block_size = n / nblocks;	unsigned b, ind;	for (b = 0; b < nblocks; b++)	{		starpu_data_acquire(starpu_data_get_sub_data(handle, 1, b), STARPU_R);		for (ind = 0; ind < block_size; ind++)		{			FPRINTF(stderr, "%2.2e ", ptr[b*block_size + ind]);		}		FPRINTF(stderr, "| ");		starpu_data_release(starpu_data_get_sub_data(handle, 1, b));	}	FPRINTF(stderr, "\n");}static void display_matrix(void){	unsigned i, j;	for (i = 0; i < n; i++)	{		for (j = 0; j < n; j++)		{			FPRINTF(stderr, "%2.2e ", A[j*n + i]);		}		FPRINTF(stderr, "\n");	}}#endif/* *	Main loop */static int cg(void){	double delta_new, delta_0;	int i = 0;	int ret;	/* r <- b */	ret = copy_handle(r_handle, b_handle, nblocks);	if (ret == -ENODEV) return ret;	/* r <- r - A x */	ret = gemv_kernel(r_handle, A_handle, x_handle, 1.0, -1.0, nblocks, use_reduction);	if (ret == -ENODEV) return ret;	/* d <- r */	ret = copy_handle(d_handle, r_handle, nblocks);	if (ret == -ENODEV) return ret;	/* delta_new = dot(r,r) */	ret = dot_kernel(r_handle, r_handle, rtr_handle, nblocks, use_reduction);	if (ret == -ENODEV) return ret;	starpu_data_acquire(rtr_handle, STARPU_R);	delta_new = rtr;	delta_0 = delta_new;	starpu_data_release(rtr_handle);	FPRINTF(stderr, "*************** INITIAL ************ \n");	FPRINTF(stderr, "Delta 0: %e\n", delta_new);	double start;	double end;	start = starpu_timing_now();	while ((i < i_max) && ((double)delta_new > (double)(eps*eps*delta_0)))	{		double delta_old;		double alpha, beta;		starpu_iteration_push(i);		/* q <- A d */		gemv_kernel(q_handle, A_handle, d_handle, 0.0, 1.0, nblocks, use_reduction);		/* dtq <- dot(d,q) */		dot_kernel(d_handle, q_handle, dtq_handle, nblocks, use_reduction);		/* alpha = delta_new / dtq */		starpu_data_acquire(dtq_handle, STARPU_R);		alpha = delta_new/dtq;		starpu_data_release(dtq_handle);		/* x <- x + alpha d */		axpy_kernel(x_handle, d_handle, alpha, nblocks);		if ((i % 50) == 0)		{			/* r <- b */			copy_handle(r_handle, b_handle, nblocks);			/* r <- r - A x */			gemv_kernel(r_handle, A_handle, x_handle, 1.0, -1.0, nblocks, use_reduction);		}		else		{			/* r <- r - alpha q */			axpy_kernel(r_handle, q_handle, -alpha, nblocks);		}		/* delta_new = dot(r,r) */		dot_kernel(r_handle, r_handle, rtr_handle, nblocks, use_reduction);		starpu_data_acquire(rtr_handle, STARPU_R);		delta_old = delta_new;		delta_new = rtr;		beta = delta_new / delta_old;		starpu_data_release(rtr_handle);		/* d <- beta d + r */		scal_axpy_kernel(d_handle, beta, r_handle, 1.0, nblocks);		if ((i % 10) == 0)		{			/* We here take the error as ||r||_2 / (n||b||_2) */			double error = sqrt(delta_new/delta_0)/(1.0*n);			FPRINTF(stderr, "*****************************************\n");			FPRINTF(stderr, "iter %d DELTA %e - %e\n", i, delta_new, error);		}		starpu_iteration_pop();		i++;	}	end = starpu_timing_now();	double timing = end - start;	FPRINTF(stderr, "Total timing : %2.2f seconds\n", timing/10e6);	FPRINTF(stderr, "Seconds per iteration : %2.2e\n", timing/10e6/i);	return 0;}static int check(void){	return 0;}static void parse_args(int argc, char **argv){	int i;	for (i = 1; i < argc; i++)	{	        if (strcmp(argv[i], "-n") == 0)		{			n = (int long long)atoi(argv[++i]);			continue;		}	        if (strcmp(argv[i], "-maxiter") == 0)		{			i_max = atoi(argv[++i]);			if (i_max <= 0)			{				FPRINTF(stderr, "the number of iterations must be positive, not %d\n", i_max);				exit(EXIT_FAILURE);			}			continue;		}	        if (strcmp(argv[i], "-nblocks") == 0)		{			nblocks = atoi(argv[++i]);			continue;		}	        if (strcmp(argv[i], "-no-reduction") == 0)		{			use_reduction = 0;			continue;		}		if (strcmp(argv[i], "-h") == 0 || strcmp(argv[i], "--help") == 0 || strcmp(argv[i], "-help") == 0)		{			FPRINTF(stderr, "usage: %s [-h] [-nblocks #blocks] [-n problem_size] [-no-reduction] [-maxiter i]\n", argv[0]);			exit(-1);		}        }}int main(int argc, char **argv){	int ret;	/* Not supported yet */	if (starpu_get_env_number_default("STARPU_GLOBAL_ARBITER", 0) > 0)		return 77;	parse_args(argc, argv);	ret = starpu_init(NULL);	if (ret == -ENODEV)		return 77;	STARPU_CHECK_RETURN_VALUE(ret, "starpu_init");	starpu_cublas_init();	generate_random_problem();	register_data();	partition_data();	ret = cg();	if (ret == -ENODEV)	{		ret = 77;		goto enodev;	}	ret = check();	starpu_task_wait_for_all();enodev:	unregister_data();	free_data();	starpu_cublas_shutdown();	starpu_shutdown();	return ret;}
 |